Skip to main content

OmicsARules: a R package for integration of multi-omics datasets via association rules mining

Abstract

Background

The improvements of high throughput technologies have produced large amounts of multi-omics experiments datasets. Initial analysis of these data has revealed many concurrent gene alterations within single dataset or/and among multiple omics datasets. Although powerful bioinformatics pipelines have been developed to store, manipulate and analyze these data, few explicitly find and assess the recurrent co-occurring aberrations across multiple regulation levels.

Results

Here, we introduced a novel R-package (called OmicsARules) to identify the concerted changes among genes under association rules mining framework. OmicsARules embedded a new rule-interestingness measure, Lamda3, to evaluate the associated pattern and prioritize the most biologically meaningful gene associations.

As demonstrated with DNA methlylation and RNA-seq datasets from breast invasive carcinoma (BRCA), esophageal carcinoma (ESCA) and lung adenocarcinoma (LUAD), Lamda3 achieved better biological significance over other rule-ranking measures. Furthermore, OmicsARules can illustrate the mechanistic connections between methlylation and transcription, based on combined omics dataset. OmicsARules is available as a free and open-source R package.

Conclusions

OmicsARules searches for concurrent patterns among frequently altered genes, thus provides a new dimension for exploring single or multiple omics data across sequencing platforms.

Background

Disease initiation and progression often result from multiple aberrations at multiple regulation dimensions. The improvements of high throughput technologies have enabled them to be precisely characterized at epigenetic, genomic, transcriptomic, proteomic and metabolomic levels [1,2,3]. While this opens the door to a systems-based research approach, there is an urgent demand of novel methods to better illustrate the underlying mechanistic connections within or across different omics datasets.

Previously, analyzing the cancer genomic data have identified associated mutations among a few genes. For example, George et al. have conducted whole genome sequencing on 110 small cell lung cancers (SCLC). They found TP53 and RB1 are universally mutated in all but two cases, which supported TP53 and RB1 follow the classical discrete ‘two-hit paradigm’ pattern of Knudson type tumor suppressors in SCLC [4]. Indeed, integrative analysis of multi-modal datasets of the same cancer tissue further revealed that some genes often concurrently altered at multiple regulation levels [5, 6]. For instance, adult cases of de novo acute myeloid leukemia were analyzed using genome sequencing along with RNA/microRNA sequencing and DNA-methylation chip. The multi-omics datasets showed that gene fusion events were correlated with specific patterns of mRNA expression, and the occurrences of specific mutations were associated with some expression signatures [6]. Importantly, the co-occurrence pattern among significantly mutated genes, hyper (hypo)-methlylated genes or differentially expressed genes often imply potential mechanistic relationships [4, 7,8,9].

In data mining field, the frequently co-occurring items are called frequent item sets. Their associated relationship (rules) can be efficiently mined via Apriori algorithm [10]. Originated from market basket data analysis, association rules mining (ARM) is a popular and well established method for discovering strong relationship between frequent items [11]. Alike to find frequent items and concurrent pattern in commercial datasets, we have proposed to identify frequent molecular alterations and combinations of these events from single or multiple omics data. Our OmicsARules package, which embedded with a new rule-interestingness measure Lamda3, can evaluate the association rules to identify biologically significant patterns.

Implementation

OmicsARules is implemented in R environment to analyze omics data sets under ARM framework (Fig. 1). Input data should be a matrix with continuous variables, such as mRNA profiling dataset or DNA methylation dataset. OmicsARules provides 5 simple processing methods to discretize the continuous values into binary matrix, which indicating the presence or absence of a molecular event in each sample. Users can mine and prioritize association rules, thresholding on several measures of significance and interestingness. The output from OmicsARules includes a table listed the found associated rules with significance and interestingness measures, and graphical presentations, which efficiently organize and visualize the identified rules for further exploration. Based on combination of various alteration spectrum simultaneously obtained from different sequencing platforms (i.e. both mRNA profiling dataset and DNA methylation dataset for the same group of patients), OmicsARules can identify the concordant changes among genes, which usually indicates broader biological implications.

Fig. 1
figure 1

Schematic representation of the analysis pipeline performed by the OmicsARules

Association rules mining and its application in omics datasets

Let I = {i1, i2,. .., in} be a set of n binary attributes called items. Let D = {t1, t2,. .., tm} be a set of transactions called the database. Each transaction in D has a unique transaction ID and contains a subset of the items purchased in I. A rule is defined as an implication of the form X = > Y where X, Y I and X ∩ Y = . The sets of items (for short, item-sets) X and Y are called antecedent (left-hand-side, LHS) and consequent (right-hand-side, RHS) of the rule, respectively. Frequent item-set, which is defined as the frequently co-occurring items, composes the association rule. Finding frequent item-set is a principal theme underlying identification of association rules. Utilizing a “bottom-up” approach, Apriori is a basic algorithm for identifying association rules [10]. It extends one item at a time to generate candidate frequent item-sets, and terminates if there is no further successful extensions to be identified. At each step, candidates having an infrequent sub-pattern are eliminated. Constraints on various measures of significance and interestingness of rules, such as Support, Confidence and Lift, could be used to rank the identified association rule (See Additional file 1 for formal definitions of these measures).

In a similar sense, items usually refer to genes in omics dataset. The frequent items could be significantly mutated genes, hypo−/hyper-methlylated genes and up−/down-expressed genes, etc., which occur more frequently than expected by random chance. Transaction indicates each independent patient sample. Notably, the frequent item-set, a set of co-occurrence between the interested genes, often implies potentially vital mechanistic connections [4, 7, 8]. To illustrate the concept, a small example from the gene expression profile was shown in Table 1. Rows correspond to each patient sample whereas columns correspond to the measured genes. Zero or one in the matrix indicates whether or not that gene is dys-regulated in that sample. In this case, the item-set is I = {NEK2,TPX2, CKS1B, UBE2C, CDKN3} and an example rule for this data could be {NEK2} = > {CDKN3}, which means, if the expression of NEK2 is altered, CDKN3 is also differentially expressed.

Table 1 An example of the application of ARM to omics datasets

Lamda3 is a novel measure indicating the interestingness of rules

ARM is supposed to be used on binary datasets, so continuous omics dataset should be transformed to the binary matrix before mining association rules. However, data transformation often results to information loss. Besides, the cutoff values used in transformation are arbitrary and could have a dominant affect on the performance of ARM. To overcome these obstacles, we proposed a novel rule-interestingness measure, Lamda3 on basis of coordinated changes among genes. Suppose the input continuous matrix containing Mc, which is of size m × n, where m denoted #sample and n for #gene. After data discretization, it will be transformed into a Boolean matrix, Mb, containing ‘1’ indicating dys-regulation and ‘0’ representing insignificant change. Given an association rule, Lamda3 is defined as the ratio of the association strength between LHS genes and RHS genes, to the average association strength between the LHS gene and other genes which are not included in that rule. For simplicity, we assumed here the identified association rule is Z, A= > C, i.e. only one gene A on the LHS, and one gene C on the RHS for each rule. Then firstly, according to Mb, all the samples in Mc were divided into three parts, \( {M}_{\mathrm{c}}^2 \), \( {M}_{\mathrm{c}}^1 \) and \( {M}_{\mathrm{c}}^0 \). \( {M}_{\mathrm{c}}^2 \) contains samples with gene A to be “1” and simultaneously gene C to be “1” in the Mb. \( {M}_{\mathrm{c}}^1 \) indicates samples having inconsistent changes of these two genes of this rule. Besides, \( {M}_{\mathrm{c}}^0 \) indicates samples with both A and C to be “0” in the Mb. That is, \( {M}_{\mathrm{c}}^2 \) and \( {M}_{\mathrm{c}}^0 \) includes samples with consistent changes of these two genes in this rule, while the former matrix contains samples with both A and C are dys-regulated while the latter has normal genes. Secondly, the association strength between genes could be defined as sum of correlation significance in the \( {M}_{\mathrm{c}}^2 \) and \( {M}_{\mathrm{c}}^0 \). The corresponding P values of correlation measure can be calculated as follows:

$$ {P}_{A,C}^2\leftarrow cor\left(A,C\right)\ \mathrm{in}\ {M}_{\mathrm{c}}^2; $$
$$ {P}_{A,C}^0\leftarrow cor\left(A,C\right)\ \mathrm{in}\ {M}_{\mathrm{c}}^0.. $$

At the same time, the P values of correlations between gene A and the other genes in the matrix (except for A and C), were calculated in the \( {M}_{\mathrm{c}}^2 \) and \( {M}_{\mathrm{c}}^0 \) as follows:

$$ {P}^2\leftarrow \mathrm{median}\left({P}_{A,{g}_1}^2,{P}_{A,{g}_2}^2,\dots, {P}_{A,{g}_{\mathrm{i}}}^2,\dots \right),{g}_{\mathrm{i}}\in {M}_{\mathrm{c}}^2,\mathrm{but}\ne A,C; $$
$$ {P}^0\leftarrow \mathrm{median}\left({P}_{A,{g}_1}^0,{P}_{A,{g}_2}^0,\dots, {P}_{A,{g}_{\mathrm{i}}}^0,\dots \right),{g}_{\mathrm{i}}\in {M}_{\mathrm{c}}^0,\mathrm{but}\ne A,C; $$

where, \( {P}_{A,{g}_{\mathrm{i}}}^2\leftarrow cor\left(A,{g}_{\mathrm{i}}\right) \) in the \( {M}_{\mathrm{c}}^2 \) and \( {P}_{A,{g}_{\mathrm{i}}}^0\leftarrow cor\left(A,{g}_{\mathrm{i}}\right) \) in the \( {M}_{\mathrm{c}}^0 \). Then Lamda3 was defined as,

$$ \mathrm{Lamda}3=\frac{\log_{10}\left({P}_{A,C}^2\right)+{\log}_{10}\left({P}_{A,C}^0\right)}{\log_{10}\left({P}^2\right)+{\log}_{10}\left({P}^0\right)}. $$

An example of calculating the proposed Lamda3 was presented in Additional file 1.

Results

Lamda3 can select biologically relevant rules from single omic dataset

OmicsARules pipeline was in turn applied to single omic dataset such as mRNA RNA-seq or DNA methylation datasets from three types of cancers (BRCA, ESCA and LUAD). For each of the six datasets, the top 50 or 100 differentially changed genes were used for association rules mining. Then, we retrieved the top 20 rules ranked by various significance measures, and their average GS scores were estimated for evaluation of these rules [12].

As shown in Fig. 2a, in all comparisons from BRCA, Lamda3 performs superiorly than the other three rule-interestingness measures. The top 20 rules (based on n = 50, Supp = 0.3, Conf = 0.8) ranked by either Supp, Lift or Lamda3 from mRNA dataset or methylation dataset were shown in Additional file 2: Tables S2 and Table S3, respectively. It was noticed that these rules have similar values of Conf, Supp and Lift. But Lamda3 could better differentiate them. Genes constituting the top 20-ranked rules by Lamda3 in BRCA mRNA dataset, were all from HOXA cluster, namely HOXA3, HOXA4, HOXA5, HOXA7. HOX genes encode a highly conserved family of homeodomain-containing transcription factors that have crucial roles in specifying positional identity along the anterior–posterior body axis during embryogenesis [13]. According to their located chromosomes, the mammalian HOX genes have been classified into 4 clusters (HOXA, −B, −C, and -D). HOXA3, HOXA4, HOXA5 and HOXA7 are located on chromosome 7. Previous studies had indicated dys-regulated HOX gene expression in carcinogenesis and breast cancer metastasis. HOXA3 and HOXA7 were found to be down-regulated in the MDA-MB-231 cells compared to the non-malignant cells [14, 15]. Expression levels of HOXA3 and A5 were found to be significantly different between breast cancerous and normal tissues [16]. Loss of expression of p53 in human breast cancer was supposed to be primarily due to lack of expression of HOXA5 [17]. Although little is known about HOXA4 in breast cancer currently, the co-occurrence of HOXA3, A4, A5 and A7 in these rules identified an intimate expression relationship between HOXA4 and the other three HOXA genes, suggesting its potential role in carcinogenesis.

Fig. 2
figure 2

Quantitative assessment of the biological relationship for genes within the same association rule based on gene similarity score ARM was conducted for single omic dataset based on different parameter settings (a) BRCA, (b) ESCA and (c) LUAD. The top-ranked 20 rules identified by either Support, Lift, wcs or Lamda3, were extracted and the average gene similarity scores were calculated. Number of gene, n top-ranked abnormal gene used for ARM

As seen in Fig. 2b, Lamda3 also performs better than the other three rule-interestingness measures based on ESCA mRNA dataset. As for the ESCA methylation dataset, Lamda3 had the better performing when Support is set to be 0.2, in contrast to Support = 0.3. Also observed in Fig. 2c of LUAD mRNA dataset, the performance of Lamda3 and Lift are comparable, and both are better than the other two measures. Regarding the LUAD methylation dataset, Lamda3 achieved the best performance when including only 50 genes, but was not as good as Lift when 100 genes were included. All the corresponding top-ranked 20 rules selected either by Lamda3, Lift or Support were shown in Additional file 2: Tables S4-S7.

Overall, the performance of Lamda3 is superior to other measures for the mRNA datasets in all the three cancers. As for the methylation dataset, Lamda3 and lift performed comparable and better than other measures. Therefore, Lamda3 is capable to identify biologically significant rules.

Lamda3 can identify biologically relevant rules from combined multi-omics datasets

Multi-omics experiments provide good opportunity to explore tumor formation and development via answering questions at systems level, such as how the genetic or epigenetic factors coordinate to drive the malignance in cancer? Here, for each cancer, DNA methylation and transcriptional data were collected from the same group of patients. After processing, the top-ranked 50 differentially expressed (DE) or differentially methylated (DM) genes were combined into one single matrix according to samples IDs and then subjected to ARM. The obtained rules were filtered to retain those which LHS and RHS contain genes from different omic datasets. Then these rules were ranked according to interestness measures, Lift, Lamda3 as well as Support. Notably, wcs could not be estimated because of the lack of rank-based weights assigned to each gene under current circumstances. As indicated by GS scores in Fig. 3a, Lamda3 is higher than other two measures in all these three cancer datasets based on Supp = 0.2. When support was set to be 0.3, the performance of Lamda3 is still the best in LUAD datasets. Regarding the analysis of the BRCA and ESCA datasets based on Supp = 0.3, the average GS scores of rules ranked by these three measures were very close to each other. Overall, Lamda3 can identify more biologically significant association rules from combined multi-omics datasets. The top-ranked 20 rules (based on Supp = 0.2, Conf = 0.8) mined from the three cancers were shown in Additional file 2: Tables S8-S10.

Fig. 3
figure 3

Quantitative assessment and graphical representation of association rules from multi-omics datasets. Based on different parameter settings, ARM was conducted for multi-omics datasets from BRCA, ESCA and LUAD. a The top-ranked 20 rules identified by either Supp, Lift and Lamda3, were extracted and the average gene similarity scores were calculated; b The representative network graph as well as (c) the group graph was shown for the top-ranked 20 rules by Lamda3 from ESCA multi-omics datasets

As shown in Fig. 3b, according to their association, genes in the top-ranked 20 rules from ESCA constituted two subsets of network. PSMB9 mRNA change is the hub of one sub-network. PSMB9 locates in the class II region of the MHC (major histocompatibility complex) and encodes the proteasome subunit. In previous studies, there is no evidence of positive relationship between PSMB9 and ESCA, but PSMB9 has been suggested to be potential targets for the diagnosis and therapy for several other cancers, such as cutaneous squamous cell carcinoma and cervical cancer [18, 19]. As shown in Fig. 3b and c, the association rules {TAP1.1,ANXA5.2}= > {PSMB9.1} and {TAP1.1,KDM5B.2}= > {PSMB9.1} were identified by Lamda3. These two rules suggested a combined mechanism between TAP1 expression and DNA methylation of ANXA5/KDM5B, which leads to the abnormal expression of PSMB9 in ESCA. ANXA5 is a phospholipase A2 and protein kinase C inhibitory protein with calcium channel activity and it plays a role in cellular signal transduction, inflammation, growth and differentiation [20]. An association between ANXA5 and several cancers has been assumed [20]. KDM5B is the specific demethylase of histone H3 lysine 4 (H3K4), and its’ up-regulation can reduce H3K4 methylation level. In previous studies, a crucial role of histone lysine methylation in the epigenetic regulation of eukaryotic genes has been demonstrated, which suggested histone methylation disorders can cause cancer [21, 22]. KDM5B also involves in ESCA development and progression [23]. Here, a potential mechanistic association between the DNA methylation of KDM5B and the transcript levels of PSMB9 was proposed by Lamda3, which provided a research clue to be tested further. Interestingly, one recent paper found that, DNMT inhibitors (that removed DNA methylation) up-regulate expression of the antigen processing and presentation molecules, including PSMB9 at the RNA and protein level in a wider range of colon and ovarian cancer cell lines [24].

These two rules also showed an association of PSMB9 and TAP1 on the transcript levels. TAP1, a member of the superfamily of ATP-binding cassette (ABC) transporters, is involved in the pumping of degraded cytosolic peptides into the membrane-bound compartment. Loss of TAP1 has been reported to render some tumor cells to escape the immune surveillance and contribute to the clinical course of esophageal cancer [25]. Again, the identified rules pinpoint a mechanistic link between TAP1 and PSMB9, thus provide testable hypothesis.

Discussion

Multiple molecular events are responsible for the initiation and progression of diseases. Therefore, it is a key issue to identify the recurrent aberrations and associated changes at multi-modal data level. A standard approach is exploratory analysis of the interested cancers by querying a gene list against all available omics data [26, 27]. Also others jointly modeled individual alterations that arise from single platform over biological networks and pathway [28, 29]. Although these methods provided novel insights, few of them explicitly found and assessed the recurrent co-occurring aberrations across omics datasets. Besides, these tools usually involved sophisticated statistical modeling and scripts programming, thus have no easy-to-use access to biologists.

In this study, we applied the association mining for omics datasets. Especially, the newly developed interestness measure Lamda3 minimized the loss of information due to dichotomization, achieved better biological significance over other rule-ranking measures. Besides, OmicsARules searches for the concurrent pattern among frequent aberrations from multiple omics datasets, thus to better illustrate the underlying common mechanism.

Conclusions

OmicsARules package will be regularly updated and optimized to handle larger cancer datasets. We concluded that OmicsARules enables a new dimension to interpret the observed aberrations and regulation mechanism across high throughput platforms.

Methods

Data source and preprocessing

TCGA omics datasets of breast invasive carcinoma (BRCA), esophageal carcinoma (ESCA) and lung adenocarcinoma (LUAD) were downloaded. Each dataset includes both RNA sequencing data and DNA methylation data from the same cohort of patients. General information of these datasets was summarized in Additional file 2: Table S1.

Above datasets were subjected to OmicsARules to find biologically significant association rules. Before that, the raw data went through several preprocess steps, including removal of genes with missing values, differential expression analysis and discretization. More details are presented in Additional file 1.

Application of OmicsARules on the cancer omics datasets

Single omic dataset can input directly to find association rules after data preprocessing. Regarding multi-omics datasets, each dataset was separately subjected to the preprocess step such as differential expression analysis and discretization. Then these two binary datasets were combined according the sample IDs, and then subjected to association rule mining by OmicsARules. In order to discriminate sources of genes, suffix ‘.1’ or ‘.2’ was added behind the gene symbol, thus the former indicated genes were present in the mRNA dataset; and the latter indicated genes were from the methylation data. Finally, rule-interestingness measures, namely Lift and Lamda3, as well as Wcs (weighted condensed support) [30], were calculated to rank the rules.

Quantitative assessment of the biological significance of the identified rules

In order to assess and compare the biological significance of the rules identified by above interestingness measures, we calculated the annotated functional similarity of Gene Ontology (GO) terms, to evaluate the biological connection between gene(s) on the LHS and these on the RHS. Gene functional similarities (GS) between genes were computed with R-package ‘GOsim’ [12].

Availability and requirements

Project name: OmicsARules.

Project home page: https://github.com/BioinformaticsSTU/OmicsARules

Operating system(s): Linux, Microsoft Windows.

Programming language: R.

Other requirements: R > =3.3.2.

License: MIT License.

Any restrictions to use by non-academics: No restrictions.

Availability of data and materials

The OmicsARules package together with its installation guide, are freely accessible at https://github.com/BioinformaticsSTU/OmicsARules. Level 3 DNA methylation profiles as well as corresponding level 3 RNA sequencing data for breast invasive carcinoma, esophageal carcinoma and lung adenocarcinoma, were selected and downloaded from Genomic Data Common Data Portal (http://portal.gdc.cancer.gov/). For the convenience of users, we have uploaded the datasets on OneDrive (https://stumail-my.sharepoint.cn/:f:/g/personal/d_z_chen_stu_edu_cn/ErLfzFLiee9PjUEox0iyULEBIsE4SEwu7BVa8cYI8nQpYA?e=wic3GT).

Abbreviations

ARM:

Association Rules Mining

BRCA:

BReast invasive CArcinoma;

DE:

Differentially Expressed gene

DM:

Differentially Methylated gene

ESCA:

ESophageal CArcinoma

GO:

Gene Ontology

LHS:

Left-hand-side

LUAD:

LUng ADenocarcinoma

MHC:

Major Histocompatibility Complex

RHS:

Right-hand-side

References

  1. Chen R, Mias GI, Li-Pook-Than J, Jiang L, Lam HY, Miriami E, Karczewski KJ, Hariharan M, Dewey FE, Cheng Y, et al. Personal omics profiling reveals dynamic molecular and medical phenotypes. Cell. 2012;148(6):1293–307.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  2. Mertins P, Mani DR, Ruggles KV, Gillette MA, Clauser KR, Wang P, Wang X, Qiao JW, Cao S, Petralia F, et al. Proteogenomics connects somatic mutations to signalling in breast cancer. Nature. 2016;534(7605):55–62.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  3. Weinstein JN, Collisson EA, Mills GB, Shaw KR, Ozenberger BA, Ellrott K, Shmulevich I, Sander C, Stuart JM. The Cancer genome atlas pan-Cancer analysis project. Nat Genet. 2013;45(10):1113–20.

    Article  PubMed  PubMed Central  Google Scholar 

  4. George J, Lim JS, Jang SJ, Cun Y, Ozretic L, Kong G, Leenders F, Lu X, Fernandez-Cuesta L, Bosco G, et al. Comprehensive genomic profiles of small cell lung cancer. Nature. 2015;524(7563):47–53.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  5. Lawrence MS, Stojanov P, Polak P, Kryukov GV, Cibulskis K, Sivachenko A, Carter SL, Stewart C, Mermel CH, Roberts SA, et al. Mutational heterogeneity in cancer and the search for new cancer-associated genes. Nature. 2013;499(7457):214–8.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  6. Cancer Genome Atlas Research N, Ley TJ, Miller C, Ding L, Raphael BJ, Mungall AJ, Robertson A, Hoadley K, Triche TJ Jr, Laird PW, et al. Genomic and epigenomic landscapes of adult de novo acute myeloid leukemia. N Engl J Med. 2013;368(22):2059–74.

    Article  Google Scholar 

  7. Bailey P, Chang DK, Nones K, Johns AL, Patch AM, Gingras MC, Miller DK, Christ AN, Bruxner TJ, Quinn MC, et al. Genomic analyses identify molecular subtypes of pancreatic cancer. Nature. 2016;531(7592):47–52.

    Article  CAS  PubMed  Google Scholar 

  8. Villanueva J, Infante JR, Krepler C, Reyes-Uribe P, Samanta M, Chen HY, Li B, Swoboda RK, Wilson M, Vultur A, et al. Concurrent MEK2 mutation and BRAF amplification confer resistance to BRAF and MEK inhibitors in melanoma. Cell Rep. 2013;4(6):1090–9.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  9. Berger AH, Knudson AG, Pandolfi PP. A continuum model for tumour suppression. Nature. 2011;476(7359):163–9.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  10. Agrawal R, Imielinski T, S A. Mining association rules between sets of items in large databases. In: Proceedings of the ACM SIGMOD International Conference on Management of Data. Washington: ACM Press; 1993. p. 207–16.

  11. Hipp J, Guntzer U, N G. Algorithms for association rule mining-a general survey and comparison. SIGKDD Explor Newsl. 2000;2:58–64.

    Article  Google Scholar 

  12. Frohlich H, Speer N, Poustka A, Beissbarth T. GOSim--an R-package for computation of information theoretic GO similarities between terms and gene products. BMC Bioinformatics. 2007;8:166.

    Article  PubMed  PubMed Central  Google Scholar 

  13. Hur H, Lee JY, Yun HJ, Park BW, Kim MH. Analysis of HOX gene expression patterns in human breast cancer. Mol Biotechnol. 2014;56(1):64–71.

    Article  CAS  PubMed  Google Scholar 

  14. Svingen T, Tonissen KF. Altered HOX gene expression in human skin and breast cancer cells. Cancer Biol Ther. 2003;2(5):518–23.

    Article  CAS  PubMed  Google Scholar 

  15. Cantile M, Pettinato G, Procino A, Feliciello I, Cindolo L, Cillo C. In vivo expression of the whole HOX gene network in human breast cancer. Eur J Cancer. 2003;39(2):257–64.

    Article  CAS  PubMed  Google Scholar 

  16. Makiyama K, Hamada J, Takada M, Murakawa K, Takahashi Y, Tada M, Tamoto E, Shindo G, Matsunaga A, Teramoto K, et al. Aberrant expression of HOX genes in human invasive breast carcinoma. Oncol Rep. 2005;13(4):673–9.

    CAS  PubMed  Google Scholar 

  17. Raman V, Martensen SA, Reisman D, Evron E, Odenwald WF, Jaffee E, Marks J, Sukumar S. Compromised HOXA5 function can limit p53 expression in human breast tumours. Nature. 2000;405(6789):974–8.

    Article  CAS  PubMed  Google Scholar 

  18. Liu H, Chen D, Liu P, Xu S, Lin X, Zeng R. Secondary analysis of existing microarray data reveals potential gene drivers of cutaneous squamous cell carcinoma. J Cell Physiol. 2019. https://doi.org/10.1002/jcp.28172.

    Article  CAS  Google Scholar 

  19. Fernandez-Retana J, Zamudio-Meza H, Rodriguez-Morales M, Pedroza-Torres A, Isla-Ortiz D, Herrera L, Jacobo-Herrera N, Peralta-Zaragoza O, Lopez-Camarillo C, Morales-Gonzalez F, et al. Gene signature based on degradome-related genes can predict distal metastasis in cervical cancer patients. Tumour Biol. 2017;39(6):1010428317711895.

    Article  PubMed  Google Scholar 

  20. Sun CB, Zhao AY, Ji S, Han XQ, Sun ZC, Wang MC, Zheng FC. Expression of annexin A5 in serum and tumor tissue of patients with colon cancer and its clinical significance. World J Gastroenterol. 2017;23(39):7168–73.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  21. Varier RA, Timmers HT. Histone lysine methylation and demethylation pathways in cancer. Biochim Biophys Acta. 2011;1815(1):75–89.

    CAS  PubMed  Google Scholar 

  22. Xhabija B, Kidder BL. KDM5B is a master regulator of the H3K4-methylome in stem cells, development and cancer. Semin Cancer Biol. 2019;57:79–85.

    Article  CAS  PubMed  Google Scholar 

  23. Cui G, Liu D, Li W, Li Y, Liang Y, Shi W, Zhao S. Original research: miR-194 inhibits proliferation and invasion and promotes apoptosis by targeting KDM5B in esophageal squamous cell carcinoma cells. Exp Biol Med (Maywood). 2017;242(1):45–52.

    Article  CAS  Google Scholar 

  24. Siebenkas C, Chiappinelli KB, Guzzetta AA, Sharma A, Jeschke J, Vatapalli R, Baylin SB, Ahuja N. Inhibiting DNA methylation activates cancer testis antigens and expression of the antigen processing and presentation machinery in colon and ovarian cancer cells. PLoS One. 2017;12(6):e0179501.

    Article  PubMed  PubMed Central  Google Scholar 

  25. Zou N, Yang L, Chen L, Li T, Jin T, Peng H, Zhang S, Wang D, Li R, Liu C, et al. Heterozygote of TAP1 Codon637 decreases susceptibility to HPV infection but increases susceptibility to esophageal cancer among the Kazakh populations. J Exp Clin Cancer Res. 2015;34:70.

    Article  PubMed  PubMed Central  Google Scholar 

  26. Fernandez-Banet J, Esposito A, Coffin S, Horvath IB, Estrella H, Schefzick S, Deng S, Wang K, AC K, Ding Y, et al. OASIS: web-based platform for exploring cancer multi-omics data. Nat Methods. 2016;13(1):9–10.

    Article  CAS  PubMed  Google Scholar 

  27. Gao J, Aksoy BA, Dogrusoz U, Dresdner G, Gross B, Sumer SO, Sun Y, Jacobsen A, Sinha R, Larsson E, et al. Integrative analysis of complex cancer genomics and clinical profiles using the cBioPortal. Sci Signal. 2013;6(269):pl1.

    Article  PubMed  PubMed Central  Google Scholar 

  28. Mo Q, Wang S, Seshan VE, Olshen AB, Schultz N, Sander C, Powers RS, Ladanyi M, Shen R. Pattern discovery and cancer gene identification in integrated cancer genomic data. Proc Natl Acad Sci U S A. 2013;110(11):4245–50.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  29. Yang D, Sun Y, Hu L, Zheng H, Ji P, Pecot CV, Zhao Y, Reynolds S, Cheng H, Rupaimoole R, et al. Integrated analyses identify a master microRNA regulatory network for the mesenchymal subtype in serous ovarian cancer. Cancer Cell. 2013;23(2):186–99.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  30. Mallik S, Mukhopadhyay A, Maulik U. RANWAR: rank-based weighted association rule mining from gene expression and methylation data. IEEE Trans Nanobioscience. 2015;14(1):59–66.

    Article  PubMed  Google Scholar 

Download references

Acknowledgements

Not applicable.

Funding

This work has been supported in part by the National Natural Science Foundation of China (No. 81673037). The funding body played no roles in the design of the study and collection, analysis, and interpretation of data and in writing the manuscript.

Author information

Authors and Affiliations

Authors

Contributions

DZC developed the software package; FZ collected and interpreted data, prepared the manuscript. QQZ assisted in the package’s development, data analysis and visualization. JZX conceived the project and wrote the manuscript. All authors read and approved the final manuscript.

Corresponding author

Correspondence to Jianzhen Xu.

Ethics declarations

Ethics approval and consent to participate

Not applicable.

Consent for publication

Not applicable.

Competing interests

The authors declare that they have no competing interests.

Additional information

Publisher’s Note

Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Supplementary information

Additional file 1.

Description of R package development, datasets preprocessing and assessment of the biological significance of the identified rules.

Additional file 2: Table S1.

General information of three real datasets downloaded from TCGA. Table S2. Top 20 rules identified from BRCA mRNA dataset. Table S3. Top 20 rules identified from BRCA DNA methylation. Table S4. Top 20 rules identified from ESCA mRNA dataset. Table S5. Top 20 rules identified from ESCA DNA methylation dataset. Table S6. Top 20 rules identified from LUAD mRNA dataset. Table S7. Top 20 rules identified from LUAD DNA methylation dataset. Table S8. Top 20 rules identified from the combined BRCA mRNA and DNA methylation datasets. Table S9. Top 20 rules identified from the combined ESCA mRNA and DNA methylation datasets. Table S10. Top 20 rules identified from the combined LUAD mRNA and DNA methylation datasets.

Rights and permissions

Open Access This article is distributed under the terms of the Creative Commons Attribution 4.0 International License (http://creativecommons.org/licenses/by/4.0/), which permits unrestricted use, distribution, and reproduction in any medium, provided you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons license, and indicate if changes were made. The Creative Commons Public Domain Dedication waiver (http://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Chen, D., Zhang, F., Zhao, Q. et al. OmicsARules: a R package for integration of multi-omics datasets via association rules mining. BMC Bioinformatics 20, 554 (2019). https://doi.org/10.1186/s12859-019-3171-0

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s12859-019-3171-0

Keywords