Skip to main content
  • Research article
  • Open access
  • Published:

Comparison of statistical methods for subnetwork detection in the integration of gene expression and protein interaction network

Abstract

Background

With the advancement of high-throughput technologies and enrichment of popular public databases, more and more research focuses of bioinformatics research have been on computational integration of network and gene expression profiles for extracting context-dependent active subnetworks. Many methods for subnetwork searching have been developed. Scoring and searching algorithms present a range of computational considerations and implementations. The primary goal of present study is to comprehensively evaluate the performance of different subnetwork detection methods. Eleven popular methods were selected for comprehensive comparison.

Results

First, taking into account the dependence of genes given a protein-protein interaction (PPI) network, we simulated microarray gene expression data under case and control conditions. Then each method was applied to the simulated data for subnetwork identification. Second, a large microarray data set of prostate cancer was used to assess the practical performance of each method. Using both simulation studies and a real data application, we evaluated the performance of different methods in terms of recall and precision.

Conclusions

jActiveModules, PinnacleZ and WMAXC performed well in identifying subnetwork with relative high precision and recall. BioNet performed very well only in precision. As none of methods outperformed other methods overall, users should choose an appropriate method based on the purposes of their studies.

Background

In system biology, analysis of large biological networks has become major research topics in recent years. In order to better understand complex biological processes, diverse data sources revealing different aspect of biological functions are required for effective integration of knowledge. One of the most successful approaches has been to integrate protein–protein interaction (PPI) network with gene expression profiles to identify sets of genes and interactions that participate in a meaningful biological function, that is 'active subnetworks (modules)' [1]. Gene expression profiles monitor the transcription activities of thousands of genes simultaneously in various tissues and under diverse experimental conditions. PPI network, naturally complement interaction data primarily derived from experiments, provide a physical 'scaffold' with process-specific information that is correlated with cellular processes or disease states [2]. With the development of popular public databases, more and more research focuses of bioinformatics research have been to computational integration of network and gene expression profiles for extracting context-dependent active subnetworks.

Searching for active subnetworks has been a computationally difficult problem, known as Non-deterministic Polynomial-time (NP)-hard problem. Many methods for subnetwork searching have been developed, presenting a range of computational considerations and implementations. Different scoring functions have imposed scores on network nodes or edges or both [2, 3]. Besides, high-scoring nodes were prioritized as ‘seed genes’ for searching [4, 5]. Many searching algorithms, such as greedy searching, simulated annealing, genetic algorithms, have been proposed and applied to identify active subnetworks in recent studies. Because of the diversity of scoring functions and searching algorithms, it is impossible to obtain identical or similar subnetworks given the same input expression profiles and PPI network.

The primary goal of present study is to comprehensively evaluate the performance of different subnetwork detection methods. 11 methods were selected for comprehensive comparison. First, taking into account the dependence of genes given a PPI network, we simulated microarray gene expression data under case and control conditions. Then each method was applied to the simulated data for subnetwork identification. Second, an authoritative microarray data set of prostate cancer was used to assess and compare the performance of each method.

Methods

Subnetwork detection methods for comparison

As gene expression profiles can capture the transcription activities of thousands of genes simultaneously correlated with cellular or disease states, and PPI network provide a physical 'scaffold' with cell process-specific information, the integration of PPI network with gene expression profiles has become one of the most popular integrative approaches for extracting context-dependent active subnetworks. During the past decade various algorithms have been specifically developed to identify subnetworks in PPI network by integrating gene expression data and PPI network. 11 subnetwork detection methods were selected for comprehensive assessment based on the following rules. The input for each algorithm must be a network and an expression matrix or a list of seed genes or summary statistics based on the differential gene expression analysis. A brief summary of each method were given in the Table 1.

Table 1 Description of subnetwork detection methods

jActiveModules is a plugin package in software Cytoscape. From a molecular interaction network it conducts searches of expression activated subnetworks [2], which show significant changes in expression over different conditions. The method combines a rigorous statistical measure for scoring subnetworks for finding subnetworks with high score through two different search algorithms: simulated annealing (jAM_SA) and greedy search (jAM_GS). The simulated annealing is aimed to search for the most highly scored subnetwork and the greedy search extends a subnetwork by adding one of its neighboring genes that maximizes a mutual information–based function. The input of jActiveModules is p-values of genes in the differential expression analysis between the two experimental conditions. For both search algorithms in jActiveModule, search depths from 1 to 3 were tested and maximum number of modules was set as 1.

BioNet is an R package for detection of functional modules through the integrative analysis of protein-protein interaction networks and gene expression profile. First, gene p-values calculated from the differential expression analysis are assigned to the nodes of the network. Second, based on gene p-values, scores are calculated by fitting a beta-uniform mixture model and then overall scores of network regions can be calculated. Third, subnetwork detection is modeled as a Prize-Collecting Steiner Tree (PCST) problem and an integer linear programming algorithm identifies the maximum scoring subnetwork [6, 7]. The BioNet allows for the fine tuning of the signal noise decomposition by the false discovery rate (FDR), therefore we scanned a range of FDRs to guarantee desirably sized modules and evaluated the obtained solutions in terms of recall and precision.

Bagging Markov random field (BMRF) approach is a BMRF-based method for subnetwork identification in the integration PPI data and microarray data with two different phenotypes (case/control). The BMRF approach integrates gene expression and PPI data based on on a framework of Markov random field modelling and maximum a posteriori estimation. It improves the subnetwork identification with a modified simulated annealing search algorithm and a so-called bagging aggregation scheme [8]. In BMRF, the parameter T, which controls the sharpness of the distribution of network score function, was set to 1 and the other parameter d distance was tested ranging from 1 to 3.

Functional epigenetic modules (FEM) algorithm is a functional supervised algorithm. It encapsulates the strength of associations of the genes with the phenotype in terms of the edge weights, in order to identify modules (subnetworks), where the edge weight density (called modularity) is significantly higher than in the rest of the network [9, 10]. An efficient spin-glass (SPG) module detection algorithm was used to identify modules, as it maximizes a relative weight density centered around specific seeds. The statistical significance of any inferred modules was assessed based on 1000 permutations, in which the node statistics were randomly permuted over the network followed by re-computation of the modularity values. One main tunable parameter (λ) in the FEM algorithm is used to determine the size of the inferred modules. We tuned λ to yield modules in a size range and evaluated them in terms of recall and precision.

Condition specific sub-network (COSINE) aims to identify a single optimal subnetwork of genes showing maximal alternation in terms of the expression pattern, given two or more microarray expression profiles under different conditions (case vs. control, etc.) [11]. In COSINE, a scoring function is used to jointly measure the differential expression of each gene (node) and gene-gene co-expression (edge). The parameter λ (0 ≤ λ ≤ 1) is a weight parameter to adjust for the size of the subnetwork in the PPI network. It uses the genetic algorithm to search for the single optimal subnetwork which maximizes the scoring function. A simple empirical procedure is used to select weight parameter λ, making it adaptive to the specific datasets being analyzed. As to the optimized choice of λ, we followed the procedure in the original paper [11].

ClustEx is a two-step method for identifying gene modules by integrating gene expression and PPI [4]. In the clustering step, the differentially expressed genes (DEGs) were clustered and partitioned into different groups by average linkage hierarchical clustering according to their distances in gene networks. In the extending step, the final gene modules were formed by adding intermediate genes on the k-shortest paths between the DE genes. It requires a seed gene set based on the DE analysis and the largest output cluster will be considered as the final subnetwork.

Weighted maximum clique (WMAXC) method aims to identify a condition-specific sub-network [12]. The weight of nodes and edges in a PPI network are calculated by scoring functions to measure differential expression of genes and gene-gene co-expressions for given two conditions. Then the maximal scoring subnetwork is identified by an optimization model. In WMAXC, A weight parameter λ is chosen to be adaptive to the dataset being analyzed and make the solution stable to the problem through a optimization model [12].

PinnacleZ is a Cytoscape plugin for classifying gene expression data by integrating gene expression and PPI network [13]. PinnacleZ requires three sources of input: a gene expression matrix, a class file and a PPI network. It scores subnetworks using the mutual information between aggregated gene Z-scores and sample labels. A greedy search is performed to find local subnetworks. In PinnacleZ, search depths from 1 to 3 were tested to provide a sufficient number of neighbors while keeping the search local.

Klein-Ravi (KR) algorithm will use a connected graph from seed genes as an initial tree [5, 14]. The iteration of the algorithm selects a non-tree node and a subset of at least two of the current trees to minimize the ratio called quotient cost. Once a node is selected, the shortest path is used to merge node and trees into one. For more details of the algorithm, please refer to the original paper [14].

The limited K-walks (kwalk) algorithm simulates random walks on a graph by the Markov Chain model [5, 15]. The relevance of an edge and a node in relation to the seed genes is evaluated by the expected times random walk passes starting from one seed to any of the others. A detailed elaboration can be found in the original paper [15].

Results

Simulation studies

PPI data was downloaded from the database of HPRD (Human Protein Reference Database, http://www.hprd.org/download), Release 9, 2010. To reduce the computational complexity, a subset PPI network containing 5,195 genes and 18,158 interactions was extracted from HPRD database. In this PPI network, 274 genes were randomly selected to be considered as the ground truth subnetwork of interactions. Given the PPI network and the ground truth subnetwork, gene expression data was simulated through two models considering the inter-dependence of genes in the network.

First, an MRF model was employed to determine the states of genes as ‘differentially expressed’ or ‘non-differentially (equally) expressed’ in the PPI network given the ground truth subnetwork. Let X be a binary vector indicating the states of genes in a PPI network G, 0 representing ‘equally expressed (EE)’ and 1 representing ‘differentially expressed (DE)’. The ground truth differential subnetwork was denoted as G0, which means X {G0} = 1 and X {G-G0} = 0. Then we can sample the gene state according to the following probability based on a Markov random field model: p i (k|)  exp(γ k  − βμ i (1 − k)), where γ k and β were the parameters predefined, and μ i (1-k) denoted the number of neighbors of gene i having state 1-k, k = 0, 1. To introduce false positives in the sampled differential subnetwork, one more parameter (w) was added to control the probability of keeping initial states of ground truth DE genes and background EE genes. Here μ i (1-k) was defined as a function of parameter w as follows: \( {\mu}_i\left(1- k\right)=\frac{w\cdot \left(1-{X}_i^{1- k}\right)+{\displaystyle \sum_{j\in {N}_i}\left(1-{X}_j^{1- k}\right)}}{w+{\displaystyle \sum_{j\in {N}_i}\left({X}_j^{1- k}+{X}_j^k\right)}},\kern0.5em \mathrm{where}\kern1em {X}^1= X,{X}^0=1- X. \) Here we chose w at 50 to generate simulation gene expression data set.

Second, based on the states of the genes, the gene expression levels were modeled in a Gamma-Gamma (GG) model, in which the observed variable y (gene expression level) follows a Gamma distribution having shape parameter α > 0 and scale parameter β g , with a mean value μ g  = αβ g . Mathematically, the probability density function of the GG model is defined by: \( p\left( y\Big|\alpha, {\beta}_g\right)=\frac{y^{\alpha -1} \exp \left\{- y/{\beta}_g\right\}}{\beta_g^{\alpha}\varGamma \left(\alpha \right)} \). To finally generate simulation data, we fist sampled the scale parameter β g based on Gamma distribution (α 0 , ν) and then sampled gene expression levels using parameters (α, β g ) given the states of genes. The parameters were the same as those in Newton et al. [16] (α = 10, α0 = 0.9 and ν = 0.5). Based on the differential state and gene dependency, the gene expression data were simulated with 50 samples in each phenotype (100 samples in total).

Subnetwork identification performance assessment

As some methods do not prioritize genes in the subnetwork, we cannot use the area under the receiver operating characteristic (ROC) curve (AUC) as a criterion to evaluate the performance. Therefore, recall, precision and the combined F-measure were used to evaluate the performance of different methods. Precision and recall were defined as follows: Precision = (Srecovered ∩ Sground)/Srecovered = TP/TP + FP; Recall = (Srecovered ∩ Sground)/Sground = TP/TP + FN, where true positive (TP) denotes the number of correctly identified genes, false positive (FP) denotes the number of falsely identified genes and false negative (FN) denotes the number of falsely unidentified genes. \( {\mathrm{S}}_{\mathrm{recovered}} \) indicated the number of genes in the recovered subnetwork after applying each subnetwork identification method and \( {\mathrm{S}}_{\mathrm{ground}} \) indicated the number of genes in the ground truth subnetwork. The traditional F-measure or balanced F-score (F 1-score) is the harmonic mean of precision and recall, and can be used as a measure of total accuracy when equal importance is attached to recall and precision.

Performance comparisons of these methods were shown in Table 2. We can see that BioNet had the highest precision result, followed by jAM_GS and WMAXC. This is interesting because BioNet does not depend on a seed gene set but the significance of the gene expression. jAM_SA had the highest recall, followed by PinnacleZ, because jAM_SA used simulated annealing search. Different from other methods, ClustEx needed two-steps for subnetwork identification based on the assumption that a group of closely-connected differential genes were the signatures of the subnetworks. ClustEx had poorest performance among all the methods. Another poorest method is Cosine, possibly because it searched for the single optimal sub-network which jointly measures the changes of nodes as well as edges.

Table 2 Performance comparison on the simulated data for the subnetwork detection methods

Comparison on real data set with integration of PPIs

The performance of each method was tested using real data integrated with PPI network. Prostate cancer (PC) gene expression data was used (GSE3933), which contained the gene expression profiles of 71 prostate tumor and 41 normal samples [17]. Missing values in probes were imputed by the mean of observations and then data were standardized. Mean value of multiple probes mapped to a gene was computed as the expression level for that gene. Genes, which were contained both in PC gene expression profiles and HPRD PPI network, were included in the subsequent network analysis. After excluding self-interactions, there were 5335 genes (nodes) and 18234 interactions (edges). For the method evaluation, 703 genes related to PC from the Dragon Database of Genes associated with Prostate Cancer (DDPC) were used as reference genes [18]. This database comprehensively included genes all experimentally verified to be associated with PC. Among the 703 genes, 400 were included in the 5335 genes.

Fold enrichment was used to evaluate the performance of the methods and was calculated as (# of recovered genes)*5335/400*(# of selected genes), where selected genes were genes selected by the method, recovered genes were genes recovered by the method among the 400 reference genes, and 5335 represented the number of all genes in the entire network.

Table 3 showed the results of method comparison in real data set. The subnetwork size ranged from 196 to 1559. For example WMAXC extracted a subnetwork of the size 539 and resulted in a fold enrichment of 2.35. PinnacleZ had the highest fold enrichment of 2.49 with a subnetwork size of 246. It indicated that PinnacleZ outperformed all the other methods, although in the simulation data set, PinnacleZ had similar F-measure with jAM_GS and WMAXC.

Table 3 Performance comparison on prostate cancer gene expression data and PPI for the subnetwork detection methods

Computational complexity and program usability

Apart from accuracy, another important attribute for each method is computational complexity. When dealing with a large high-dimensional data set, some methods may become unfeasible. BMRF and jAM_SA may cause such concerns. Most other methods would finish computing within reasonable time on standard desktop hardware even for large data sets. The usability of each method is determined by users’ familiarity with a particular platform (R, Matlab, JAVA and Python). jActiveModules and PinnacleZ are Cytoscape plugins, which offered notable user-friendly features with network analysis as well as convenient visualization functions. Similarly, BioNet will also provide analysis and visualization functions.

Discussion

In the present study, we have performed a comprehensive assessment of various methods for subnetwork detection using simulation data and prostate cancer data. The key conclusion in this study can be summarized as follows.

First, although each of the methods was claimed to be effective in their original publications, based on the simulation scheme and read data sets they used. The subnetwork detection problem still needs further investigation. jActiveModules, PinnacleZ and WMAXC performed well in identifying subnetwork with relative high precision and recall. BioNet performed very well only in precision. As none of methods outperformed other methods overall, users should choose an appropriate method based on the purposes of their studies. Among the above four methods, for example, if only the summary statistics and p values are available in the study, BioNet will be a best choice of giving an exact functional module. If the study is interested in identifying subnetworks from selected genes/nodes, the best solution is jActiveModules, which provides options for searching from selected nodes and search depth. We suggest that investigators could use a combination of several different methods based on different principles. We suggest that a combination of BioNet, jActiveModules and PinnacleZ could be used.

Second, in terms of ease of use, some of the methods do not offer use-friendly interface or visualization functions for identified subnetworks. It is worth mentioning that the java plugins jActiveModules and PinnacleZ facilitate the analysis and visualization of subnetworks within an interface to Cytoscape.

Third, we found that the BMRF and jAM_SA were not applicable to large data sets, because of the computational complexity as well as the memory requirements for both methods increase greatly as the number of seeds increases.

Lastly, we suggest that interactome data (PPI) can be dissected and reorganized using high-level structures, such as pathways and GO terms. Those high-level structures can make sure that the output subnetworks are biologically meaningful and guide subnetwork detection methods to prune a global network without losing the important biological structures.

Conclusion

In summary, the present study evaluated the performance of eleven different subnetwork detection methods. Using both simulation studies and a real data application, we evaluated the performance of different methods in terms of recall and precision. jActiveModules, PinnacleZ and WMAXC performed well in identifying subnetwork with relative high precision and recall. BioNet performed very well only in precision. As none of methods outperformed other methods overall, users should choose an appropriate method based on the purposes of their studies.

Abbreviations

AUC:

Area under the curve

BMRF:

Bagging Markov random field

COSINE:

Condition specific sub-network

DDPC:

Dragon database of genes associated with prostate cancer

DEG:

Differentially expressed genes

EE:

Equally expressed

FDR:

False discovery rate

FEM:

Functional epigenetic modules

FN:

False negative

FP:

False positive

GG model:

Gamma-Gamma model

HPRD:

Human protein reference database

jAM_GS:

Greedy search

jAM_SA:

Simulated annealing

KR algorithm:

Klein-ravi algorithm

Kwalk algorithm:

Limited K-walks algorithm

PC:

Prostate cancer

PCST:

Prize-collecting steiner tree

PPI:

Protein-protein interaction

ROC:

Receiver operating characteristic

SPG:

Spin-glass

TP:

True positive

WMAXC:

Weighted maximum clique

References

  1. Mitra K, Carvunis AR, Ramesh SK, Ideker T. Integrative approaches for finding modular structure in biological networks. Nat Rev Genet. 2013;14(10):719–32.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  2. Ideker T, Ozier O, Schwikowski B, Siegel AF. Discovering regulatory and signalling circuits in molecular interaction networks. Bioinformatics. 2002;18 Suppl 1:S233–40.

    Article  PubMed  Google Scholar 

  3. Wang YC, Chen BS. Integrated cellular network of transcription regulations and protein-protein interactions. BMC Syst Biol. 2010;4:20.

    Article  PubMed  PubMed Central  Google Scholar 

  4. Gu J, Chen Y, Li S, Li Y. Identification of responsive gene modules by network-based gene clustering and extending: application to inflammation and angiogenesis. BMC Syst Biol. 2010;4:47.

    Article  PubMed  PubMed Central  Google Scholar 

  5. Zheng S, Zhao Z. GenRev: exploring functional relevance of genes in molecular networks. Genomics. 2012;99(3):183–8.

    Article  CAS  PubMed  Google Scholar 

  6. Beisser D, Klau GW, Dandekar T, Muller T, Dittrich MT. BioNet: an R-Package for the functional analysis of biological networks. Bioinformatics. 2010;26(8):1129–30.

    Article  CAS  PubMed  Google Scholar 

  7. Dittrich MT, Klau GW, Rosenwald A, Dandekar T, Muller T. Identifying functional modules in protein-protein interaction networks: an integrated exact approach. Bioinformatics. 2008;24(13):i223–31.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  8. Chen L, Xuan J, Riggins RB, Wang Y, Clarke R. Identifying protein interaction subnetworks by a bagging Markov random field-based method. Nucleic Acids Res. 2013;41(2):e42.

    Article  CAS  PubMed  Google Scholar 

  9. West J, Beck S, Wang X, Teschendorff AE. An integrative network algorithm identifies age-associated differential methylation interactome hotspots targeting stem-cell differentiation pathways. Sci Rep. 2013;3:1630.

    Article  PubMed  PubMed Central  Google Scholar 

  10. Jiao Y, Widschwendter M, Teschendorff AE. A systems-level integrative framework for genome-wide DNA methylation and gene expression data identifies differential gene expression modules under epigenetic control. Bioinformatics. 2014;30(16):2360–6.

    Article  CAS  PubMed  Google Scholar 

  11. Ma H, Schadt EE, Kaplan LM, Zhao H. COSINE: COndition-SpecIfic sub-NEtwork identification using a global optimization method. Bioinformatics. 2011;27(9):1290–8.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  12. Amgalan B, Lee H. WMAXC: a weighted maximum clique method for identifying condition-specific sub-network. PLoS ONE. 2014;9(8):e104993.

    Article  PubMed  PubMed Central  Google Scholar 

  13. Chuang HY, Lee E, Liu YT, Lee D, Ideker T. Network-based classification of breast cancer metastasis. Mol Syst Biol. 2007;3:140.

    Article  PubMed  PubMed Central  Google Scholar 

  14. Klein P, Ravi R. A Nearly Best-Possible Approximation Algorithm for Node-Weighted Steiner Trees. J Algorithms. 1995;19(1):104–15.

    Article  Google Scholar 

  15. Dupont P, Callut J, Dooms G, Monette J-N, Deville Y, Sainte B. Relevant subgraph extraction from random walks in a graph. Universite catholique de Louvain, UCL/INGI, Number RR 2006, 7.

  16. Newton MA, Kendziorski CM, Richmond CS, Blattner FR, Tsui KW. On differential variability of expression ratios: improving statistical inference about gene expression changes from microarray data. J Comput Biol. 2001;8(1):37–52.

    Article  CAS  PubMed  Google Scholar 

  17. Lapointe J, Li C, Higgins JP, van de Rijn M, Bair E, Montgomery K, Ferrari M, Egevad L, Rayford W, Bergerheim U, et al. Gene expression profiling identifies clinically relevant subtypes of prostate cancer. Proc Natl Acad Sci U S A. 2004;101(3):811–6.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  18. Maqungo M, Kaur M, Kwofie SK, Radovanovic A, Schaefer U, Schmeier S, Oppon E, Christoffels A, Bajic VB. DDPC: dragon database of genes associated with prostate cancer. Nucleic Acids Res. 2011;39(Database issue):D980–5.

    Article  CAS  PubMed  Google Scholar 

Download references

Acknowledgement

Not applicable.

Funding

This work was partially supported by grants from the National Institutes of Health [P50AR055081, R01AG026564, R01AR050496, R01AR057049, R01AR059781, R01MH104680], and startup funds from Tulane University and Edward G. Schlieder Endowment.

Availability of data and materials

The prostate cancer (PC) gene expression dataset used in this study is publicly available in NCBI GEO via accession number GSE3933.

Authors’ contributions

Analyzed the data: HH, DL. Study design: HH, JZ, DL, YPW, HWD. Wrote the paper: HH, JZ. Revised and approved the final version YPW, HWD. All authors read and approved the final manuscript.

Competing interests

The authors declare that they have no competing interest.

Consent for publication

Not applicable.

Ethics approval and consent to participate

Not applicable.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Hong-wen Deng.

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

He, H., Lin, D., Zhang, J. et al. Comparison of statistical methods for subnetwork detection in the integration of gene expression and protein interaction network. BMC Bioinformatics 18, 149 (2017). https://doi.org/10.1186/s12859-017-1567-2

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s12859-017-1567-2

Keywords