Skip to main content

NET-GE: a novel NETwork-based Gene Enrichment for detecting biological processes associated to Mendelian diseases

Abstract

Background

Enrichment analysis is a widely applied procedure for shedding light on the molecular mechanisms and functions at the basis of phenotypes, for enlarging the dataset of possibly related genes/proteins and for helping interpretation and prioritization of newly determined variations. Several standard and Network-based enrichment methods are available. Both approaches rely on the annotations that characterize the genes/proteins included in the input set; network based ones also include in different ways physical and functional relationships among different genes or proteins that can be extracted from the available biological networks of interactions.

Results

Here we describe a novel procedure based on the extraction from the STRING interactome of sub-networks connecting proteins that share the same Gene Ontology(GO) terms for Biological Process (BP). Enrichment analysis is performed by mapping the protein set to be analyzed on the sub-networks, and then by collecting the corresponding annotations. We test the ability of our enrichment method in finding annotation terms disregarded by other enrichment methods available. We benchmarked 244 sets of proteins associated to different Mendelian diseases, according to the OMIM web resource. In 143 cases (58%), the network-based procedure extracts GO terms neglected by the standard method, and in 86 cases (35%), some of the newly enriched GO terms are not included in the set of annotations characterizing the input proteins. We present in detail six cases where our network-based enrichment provides an insight into the biological basis of the diseases, outperforming other freely available network-based methods.

Conclusions

Considering a set of proteins in the context of their interaction network can help in better defining their functions. Our novel method exploits the information contained in the STRING database for building the minimal connecting network containing all the proteins annotated with the same GO term. The enrichment procedure is performed considering the GO-specific network modules and, when tested on the OMIM-derived benchmark sets, it is able to extract enrichment terms neglected by other methods. Our procedure is effective even when the size of the input protein set is small, requiring at least two input proteins.

Background

Next Generation Sequencing (NGS) technologies enable the discovery of large sets of genetic variations characterizing the individual variability. One common problem is to dig out variations potentially related to different phenotypes, including susceptibility to diseases. A widely adopted procedure relies on the extraction of functional information from sets of genes or proteins already associated to the phenotype under investigation: this procedure allows extending the set of genes or proteins potentially associated to the phenotype and can therefore be useful for prioritizing large sets of experimental variations detected with NGS experiments. Functional association is routinely performed by means of statistical enrichment analysis over a gene/protein set of interest (see [1] for a comprehensive review of different approaches). Standard enrichment methods treat each gene/protein as an isolated object and completely neglect the different types of relations among molecules. However, the analysis of genes and proteins in the context of their physical interaction networks, gene regulatory networks, metabolic and signaling pathways can help in extracting new biological information (see [2] for a comprehensive review on the applications of interaction networks to the study of human diseases).

Several approaches exploiting the interaction networks for functional association analysis (network-based enrichment analysis) have emerged in the last few years [3]. These network-based methods can be broadly classified into two main classes: A) methods that use the topology of the interaction network to infer how much similar distinct sets of gene/proteins are (among them, EnrichNET [4], PWEA [5], THINKBack [6], NetPEA [7], PathNet [8], NetGSA [9], SANTA [10], SPIA [11], JEPETTO [12], PathwayExpress[13], DEGraph [14]); B) methods that identify functionally-related modules in interaction networks and then infer protein/gene biological roles from such modules (among them, FunMod [15], PINA [16], MetaCORE [17]). In both classes, graph-theoretic measures and graph properties(such as shortest paths, degree, etc) are commonly used to extract information from the interaction network. Most methods deal with pathway enrichment analysis, some of them with both pathway and Gene Ontology (GO) terms. Among the publicly available tools that perform GO enrichment analysis, EnrichNet [4] and PINA [16] are two of the most cited methods, representative of the A and B classes above, respectively.

PINA (Protein Interaction Network Analysis) is a web resource based on the integration of six protein-protein interaction databases (IntAct [18], MINT [19], BioGRID [20], DIP [21], HPRD [22] and MIPS MPact [23]). The core of PINA consists of a computational pre-analysis of the molecular interaction network aiming at identifying clusters of densely interconnected nodes, which are likely to represent sets of functionally related proteins. Each cluster is annotated, through a standard enrichment analysis, with terms derived from different biological databases (KEGG [24], PFAM [25], GO [26]). Given an input dataset of genes/proteins, they are mapped on the pre-computed clusters and the overrepresented clusters are identified by means of a hypergeometric enrichment test. The input dataset is then characterized by the significantly enriched annotations of the overrepresented clusters. EnrichNet is a web platform for enrichment analysis based on a network integrating different information: molecular interactions (STRING [27]), cellular pathways (KEGG [24], BioCarta [28], WikiPathways [29], REACTOME [30], PID [31]), biological annotations (GO [26], InterPro [32]) and tissue-specific gene expression data. EnrichNet introduces i) a network-based distance between sets of proteins, computed by means of a random walk with a restart procedure; ii) a statistical framework for assessing the significance of distance between two protein sets. These measures allow comparing an input protein set with all the sets of proteins that share the same annotation term on the network. Given an input set, its network-based distances are computed and the annotations corresponding with significantly close sets are retained.

Here we introduce a method for enrichment analysis that implements a novel computational strategy designed to mine and extract information from publicly available interactomics datasets. Our method falls within class B and, similarly to PINA, it is based on a preprocessing phase aimed at identifying interconnected and compact modules in a molecular interaction network. However, differently from all the other approaches in class B, the modules found by our method are function-specific by construction, since they are built starting from seed sets collecting all the proteins related to a specific biological annotation. We make use of graph-theoretic and information-theoretic measures to extend the seed sets into connected subgraphs of a molecular interaction network. Each subgraph represents a compact and function specific module in the interaction network. Our enrichment pipeline consists of two independent analyses: a standard enrichment and a network-based enrichment. The network-based analysis is performed by mapping an input set of proteins into the pre-computed network modules and by collecting the corresponding annotations for an enrichment test. The network-based enrichment allows the detection of statistical associations not directly inferable from the annotations of the starting protein set, and thus not detectable through the standard enrichment. Here, we test the ability of our network-based approach to detect novel biological associations for sets of proteins related to 244 different Mendelian diseases that are associated to two or more proteins, according to the Online Catalog of Human Genes and Genetic Disorders of Mendelian Inheritance in Man (OMIM) [33].

Methods

Interaction network and protein annotations

The human protein interaction network was downloaded from STRING [27] (release 9.1). We retained all the links with documented action (file protein.actions.v9.1.txt.gz on the STRING website), irrespectively of the STRING score and of the supporting evidence. The actions associated to the links are activation, binding, catalysis, expression, post-translational modification, and reaction. The resulting network consisting of 16,958 nodes and 457,546 links, summarizes a large variety of interactions types and integrates different large datasets.

All the nodes in STRING were unambiguously mapped onto UniProtKB, using the UniProt id mapping data file [34]. Human proteins in UniProtKB were annotated with Gene ontology (GO) terms for Biological Process (BP) [26, 35], as retrieved from the UniProt-GOA web resource [36]. Out of 138,517 human proteins included in UniProtKB, 37,743 are annotated with 12,785 different GO BP terms. A total of 14,056 annotated proteins are mapped on the STRING interactome and a total of 12,621 out of 12,785 GO BP terms are represented in the STRING network. For 8,098 terms, it is possible to extract specific modules from the STRING network, containing a total of 33,315 proteins (see "Module extraction" section for details).

General workflow of the enrichment pipeline

Given a set of input proteins, our pipeline implements the novel network-based enrichment and a standard one.

The standard enrichment is performed with a Bonferroni-corrected Fisher's exact test to highlight the overrepresented BP terms associated to the input proteins, as annotated in UniProtKB. All the human proteins in UniProtKB with at least one BP annotation are used as background for the Fisher's test (37,743 protein identifiers and 12,785 related BP terms).

The network-based enrichment relies on a preprocessing phase aimed at extracting modules starting from seed sets of proteins sharing the same GO BP annotation. By construction, a module is a compact and connected subgraph of the molecular-interaction network. Given a GO BP term (our reference GO term), the corresponding module contains all the proteins directly annotated with the same term in UniProtKB (seed nodes) and some of their interacting partners (connecting nodes). The module is determined by computing all the shortest paths among the seeds and by reducing the resulting network into the minimal connecting network preserving the distances among seeds. The minimal connecting network adds to the seeds a set of connecting nodes that are more reliably related to the reference GO term. The details of module extraction are given below and the algorithmic description is available in the Additional file 1. The enrichment procedure determines whether there are significant overlaps between the input proteins and the network modules built for each GO BP term. In addition, in the network-based enrichment, the Bonferroni-corrected Fisher's exact test is adopted. The whole set of human proteins in the network-modules is used as background for the Fisher's test (33,315 protein identifiers and 8,098 related GO BP terms).

The output of the pipeline consists of a non-redundant ranking of GO BP terms overrepresented in the input set, ranked according to their Bonferroni-corrected p-values. It is important to notice that with a standard enrichment only GO terms already associated to input proteins can result as overrepresented. On the contrary, the network-based enrichment allows to detect statistical associations with GO terms not included in the annotations of the input protein set. Such terms represent the added-value information of the network-based enrichment analysis.

Module extraction

The module extraction is schematized in Figure 1 and includes four steps. We extract modules for 8,098 out of 12,621 GO BP terms represented in the STRING network. For each reference GO BP term, all the proteins in the network that are directly annotated with the same term are collected in a seed set (Figure 1, step 1). Each seed set is then extended into a function-specific module, i.e. a compact and connected subgraph of the STRING network. The function-specific module is built in three steps: extraction of the shortest path network (Figure 1, step 2), reduction to the minimal network (Figure 1, steps 3 and 4) and quality filtering, as detailed below.

Figure 1
figure 1

Outline of the network module generation of NET-GE. Details on the different steps are explained in Methods. *Ranking scores are hierarchically applied.

Extraction of the shortest path network

We extract the sub-network of STRING consisting of all the shortest paths between the proteins in the seed set. Seed proteins not appearing in STRING are kept as isolated nodes in the shortest path network. For the shortest paths computation, we do not make use of the edge-scores provided in STRING, i.e. we treat STRING as an undirected and unweighted graph, without self-loops. The size of the shortest path networks extracted from STRING is usually large, even for relatively small input protein sets. On average, the shortest path networks extracted for the different GO BP terms contain 15 times more proteins than their seed sets.

Minimal connecting network

Due to the large number of retrieved connecting nodes, a minimization is applied to the shortest path network in order to simplify its topology and thus highlight its main structure. In particular, the computational goal of the procedure is to extract from the shortest path network, the smallest distance-preserving network, i.e. the smallest subgraph that preserves the shortest distances between the seed proteins. The minimization procedure is the most computationally expensive step of the module construction, as it closely resembles the Steiner tree problem [37, 38]. Furthermore, the optimal solution is usually not unique. Our implementation makes use of the following heuristic approach:

  1. i)

    The nodes in the network are split into two disjoint groups: seed nodes (i.e. the nodes related to the seed proteins) and connecting nodes (i.e. the remaining nodes in the shortest path network).

  2. ii)

    The connecting nodes are ranked according to three predefined relevance criteria. Their description is detailed in the "Ranking scores" section.

  3. iii)

    The ranked list is iteratively processed starting from the least important node.

  4. iv)

    The currently evaluated node is removed from the shortest path network only if its deletion does not increase the shortest distance between any pair of seed nodes.

Ranking scores

In the current version, the ranking of a connecting node is obtained by applying three scores (sc, ss, cc), which are used as primary, secondary and tertiary sort key, respectively.

  1. i)

    Seed centrality (sc). We say that a node connects two seed nodes if it appears in some shortest path connecting them. Thus, the seed centrality measure simply counts the number of distinct seed pairs connected by a node. This property implicitly assumes that the higher the number of seed pairs a node connects, the higher the probability that such node appears in a minimal connecting network.

  2. ii)

    Maximum semantic similarity with the reference GO term (ss). The semantic similarity measures to which extent the annotation terms of each connecting node is related to the reference GO term: a connecting node with a high semantic similarity score is more likely to be functionally related to the seed nodes. The semantic similarity is defined as the Lin's information-theoretic metric [39]. In detail, we define the maximum semantic similarity of a connecting node with respect to the reference GO term as the highest Lin's score between the GO terms associated to the connecting node/protein and the reference GO term. The background for the information content measure used in Lin's metric is given by the entire set of UniProt-GOA annotations for human proteins [36]. The maximum semantic similarity property explicitly gives more importance to connecting proteins whose annotations are more closely related to the reference GO term (see Additional file 1 for further details).

  3. iii)

    Betweenness centrality (bc). The betweenness centrality (with respect to the nodes in the seed set) is a measure of centrality of a node in a network [40]. This property is mainly used to assess a local ranking for those connecting nodes that have exactly the same ranking with respect to the previous two properties. In large shortest path networks, this happens quite often, due to the limited range of values of the previous two properties above.

As for the shortest path network, seed proteins not appearing in STRING are kept as isolated nodes in the minimal networks. Differently from the shortest path networks, the minimal connecting networks are quite compact. On the average, they contain only 1.5 times more proteins that their seed sets. One example of a shortest path network is provided in Figure 2.

Figure 2
figure 2

Minimal connecting network for GO:0036018. A) Minimal connecting network extracted from STRING 9.2 (http://www.string-db.org) build for the Biological Process term GO:003601 (cellular response to erythropoietin). The seed genes, directly annotated with GO:0036018, are HGNC:MT2A, HGNC:KIT, HGNC:EPOR and HGNC:MT1X. The connecting genes HGNC:JAK2 and HGNC:IL6, recovered by the minimization procedure, are associated to GO:0019221 (cytokine-mediated signaling pathway). B) Relation between the reference GO term (GO:0036018) and the GO associated to the connecting genes (GO:0019221).

Quality filtering

A quality filtering procedure is applied to the minimal connecting networks built in the previous step. The idea is to filter out those networks for which the GO annotations of the connecting nodes are weakly related to the reference GO term. In particular, rare BP terms (i.e. BP terms with few related proteins) tend to produce minimal networks consisting uniquely of long paths. In most of such cases, the annotations of the connecting proteins are unrelated to the reference GO, and then the resulting minimal network is unlikely to include many proteins related to the reference GO. Such network-modules are discarded and not considered for the enrichment. The quality filtering procedure makes use of the maximum semantic similarity measure, as defined above. In particular, a minimal network is retained if, with respect to the reference GO term, the average maximum similarity of the connecting nodes is significantly higher than the average maximum similarity of all the nodes in STRING, as assessed by a Student's t-test with significance set to 5%. The quality test discharges 1,205 networks out of 12,621 (with sizes ranging from 3 to 137 nodes, with an average of 13).

We also filter out minimal networks that do not contain any connecting node. The number of GO BP terms for which we extract a non-trivial network is then 8,098.

Benchmark set

In order to benchmark the method, we extracted from the OMIM web resource [33] a list of genetic diseases that have been associated to two or more genes. We filtered out all the diseases associated to genes ambiguously mapped on UniProtKB. For performance assessment, we retained only the diseases associated to at least two proteins present in the function-specific network modules. We ended up with a set of 244 genetic diseases. The number of proteins associated to each selected disease ranges from 2 to 29, with an average of 4.

Results

The annotation pipeline retrieves enriched GO BP terms computed with a standard and a network-based procedure. Both are performed with Bonferroni-corrected Fisher tests, considering a significance level of 5%. We benchmarked on the OMIM-derived benchmark set the level of annotation added by the network-based method from both a quantitative and qualitative point of view. The quantitative analysis highlights the ability of the network-based method in recovering new enriched functions. The qualitative analysis focuses on six cases for which the newly enriched terms add new biological insights, as confirmed by previously published experimental data.

Quantitative analysis on OMIM diseases

For assessing the power of the network-based enrichment, we focus uniquely on GO BP terms that are not enriched by the standard method (filtering out also all the terms that are ancestors of terms enriched by the standard method). Results are listed in Table 1. In eleven cases out of 244 (5%), neither the standard enrichment nor the network-based enrichment retrieve significantly overrepresented BP term (first row in Table 1). In 143 cases (58%) the network-based enrichment detects more terms than the standard one (last two rows in Table 1). The average number of these terms is 38 per disease. Moreover, in 86 cases (35%) the network-based procedure is able to enrich terms that were not included in the sets of annotations characterizing the input protein set (last row in Table 1). The average number of these new terms is 17. It is also worth noticing that the network-based enrichment returns significant terms in 7 cases out of the 18 where the standard method fails to provide any result (data not shown). 30% of the annotations refer to GO terms that are associated to less than 100 proteins in the human proteome, describing quite specific functions. Terms that are more common are less frequently enriched, mainly owing to the Bonferroni-corrected Fisher test that we applied (see Figure 3). Network-based methods introduce a bias towards terms associated to the most connected nodes (see in our case Figure 1S, Additional file 2). We find that the bias is also present in the case of the standard enrichment procedure that does not make use of the network information (Figure 1S).

Table 1 Functional annotation of 244 OMIM diseases with our pipeline.
Figure 3
figure 3

Number of enriched GO BP terms as a function of the frequency of occurrence in the human proteome. The x-axis groups GO BP terms based on their frequency of occurrence in the human proteome. The numbers between parentheses indicate the number of GO BP terms falling in each class.

Qualitative analysis on OMIM diseases

The newly enriched terms that are absent in the original annotations of the input genes are likely to gain new knowledge on the disease at hand. We focus the qualitative analysis on them and we detail here six case studies for which experimental validations are available for the annotations derived with our method. For all the reported cases, PINA does not return any significant association. EnrichNet enriches only terms that are already included in the annotations of the input proteins. However EnrichNet is best suited to analyze sets including at least 10 proteins, while in our case studies, four out of six cases consist of input sets comprising two to four proteins.

OMIM #133100 ERYTHROCYTOSIS, FAMILIAL, 1

The disease is characterized by the increase of the red blood cell mass and hemoglobin concentration, and by hypersensitivity of erythrocyte progenitors (myeloid cells) to erythropoietin. The disease is associated to three genes (the tyrosine-protein kinase HGNC: JAK2, the SH2B adapter protein HGNC: SH2B3, and the erythropoietin receptor HGNC: EPOR) and the standard method enriches two terms related to histone phosphorylation. NET-GE adds three terms, reported in Table 2 (see file OMIM133100.pdf in Additional file 3 for the complete annotation). Two are already present in the set of annotations of the input proteins and are related to the response to erythropoietin (one of these terms is shown in Figure 2). The novel term is related to the regulation of myeloid cell apoptosis. Interestingly enough, the involvement of this last process is reported in [41].

Table 2 GO BP terms enriched with NET-GE for OMIM disease #133100 (FAMILIAL ERYTHROCYTOSIS 1).

OMIM #143465 ATTENTION DEFICIT-HYPERACTIVITY DISORDER; ADHD

ADHD is a psychiatric disease related to the development of the nervous system in children and adolescents. It has been linked to variations in dopamine receptors HGNC: DRD4 and HGNC: DRD5. Standard enrichment is able to highlight the connection between the disorder and the dopaminergic pathway, including the second messenger intracellular pathway based on cAMP. It also enriches GO-terms related to psychiatric functions (cognition, learning) and to the response to several compounds (amphetamine, cocaine, alkaloids, ammonium ion). As reported in Table 3 the network-based procedure enriches several terms already present in the annotation of the two input proteins (see file OMIM143465.pdf in Additional file 3 for the complete annotation). In addition, in this case, they refer to behavioral characters (response to fear, stress and defense) or to the response to chemical compounds (histamine). More interestingly, new terms are enriched, highlighting processes unexpectedly involved in ADHD such as the regulation of the GABAergic pathway and the transport of aminoacids. Both these processes, although non-characterizing the input proteins, have been experimentally related to ADHD in [42] and [43].

Table 3 GO BP terms enriched with NET-GE for OMIM disease #143465 (ATTENTION DEFICIT-HYPERACTIVITY DISORDER; ADHD).

OMIM #188890 TOBACCO ADDICTION, SUSCEPTIBILITY TO

Susceptibility to tobacco addiction has been linked to four proteins (the dopamine transporter HGNC: SLC6A3, the GABAergic G-protein coupled receptor HGNC: GABBR2, the cholinergic receptor HGNC: CHRNA4 and the cytochrome P450 HGNC: CYP2A6). Standard procedure enriches the processes related to intercellular signaling and to the response to nicotine and to alkaloids. Network-based enrichment (Table 4) is able to highlight processes such as "social behavior" and "intraspecies interactions between organisms" that are relevant for tobacco addiction and that were not present among the annotations characterizing the four starting proteins (see file OMIM188890.pdf in Additional file 3 for the complete annotation). Moreover, a GO term referring to the response to cocaine is enriched. Connections between nicotine consumption and response to cocaine have been recently described at the molecular level [44].

Table 4 GO BP terms enriched with NET-GE for OMIM disease #188890 (SUSCEPTIBILITY TO TOBACCO ADDICTION).

OMIM #188050 THROMBOPHILIA DUE TO THROMBIN DEFECT; THPH1

THPH1 is a disorder of impaired clot formation linked to four different proteins: the coagulation factor HGNC: F13A1, the prothrombin HGNC: F2, the methylenetetrahydrofolate reductase HGNC: MTHFR, and the hyaluronan-binding protein HGNC: HABP2. Standard enrichment only extracts a GPCR signaling pathway, while the network based procedure is able to correctly identify the main impaired process, namely the platelet aggregation (Table 5 see file OMIM188050.pdf in Additional file 3 for the complete annotation). This term is more specific than those reported in the annotation of the input proteins.

Table 5 GO BP terms enriched with NET-GE for OMIM disease #188050 (THROMBOPHILIA DUE TO THROMBIN DEFECT; THPH1).

OMIM #608446 SUSCEPTIBILITY TO MYOCARDIAL INFARCTION

The susceptibility to myocardial infarction is linked to 12 different proteins (see file OMIM608446.pdf in Additional file 3). Both standard and network based enrichment extract different terms, already associated to the input proteins. However, NET-GE is able to add two new important processes related to the disease: regulation of angiogenesis and regulation of vasculature development (Table 6).

Table 6 GO BP terms enriched with NET-GE for OMIM disease #608446 (SUSCEPTIBILITY TO MYOCARDIAL INFARCTION).

OMIM #601665 OBESITY

Obesity is linked to 16 different proteins (see file OMIM 601665.pdf in Additional file 3). Both the standard and the network based enrichment extract many terms, already associated to the input proteins. NET-GE is able to newly enrich several processes listed in table 7. Most of these processes are known to be related to obesity. In particular, the most specific ones are: i) the sodium ion homeostasis [45]; ii) the CD4-positive, alpha-beta T cell differentiation/activation [46]; iii)the negative regulation of bile acid biosynthetic process [47]; iv) the regulation of adrenergic receptor signaling pathway [48]; v) the regulation of serotonin secretion [49]; vi) the inflammatory response [50]; vii) the negative regulation of cAMP-mediated signaling [51].

Table 7 GO BP terms enriched with NET-GE for OMIM disease #601665 (OBESITY).

Conclusions

We describe a novel computational method, NET-GE, for enrichment analysis, which exploits the information contained into molecular interaction networks. Given a set of input proteins, our method can detect functional associations not directly inferable from the annotations of the starting protein set, and thus not detectable through a standard enrichment. The method has been benchmarked on a set of 244 different Mendelian diseases associated to more than two proteins, as reported in the OMIM database. The lists of enriched terms for the benchmark examples are available in Additional file 3. NET-GE is able to enrich terms neglected by the standard method and, in a considerable amount of cases, the terms are not even included in the annotation of the input set. For some diseases, it is possible to prove that new enrichment terms are coherent with the experimental information available for the diseases. Therefore, we propose our novel network-based enrichment as a procedure helping in formulating new hypotheses on the biological processes underlying a particular phenotype for which a pool of associated proteins is known. Enriched GO-terms can suggest pools of new proteins potentially associated to the phenotype at hand and can therefore help the prioritization of new variants to be discovered with sequencing techniques. One of the advantages of our method, with respect to other similar ones, is its ability to extract new information even from very small sets of input proteins. In the current version, the network-based method makes use of the STRING network of physical interactions and analyzes only the GO BP annotations. However, the method is quite general and it does not rely on such specific interaction network and biological annotations. For future development, we plan to extend it to different networks and different biological annotations.

References

  1. Huang DW, Sherman BT, Lempicki RA: Bioinformatics enrichment tools: paths toward the comprehensive functional analysis of large gene lists. Nucl Acids Res. 2009, 37: 1-13. 10.1093/nar/gkn923.

    Article  PubMed Central  Google Scholar 

  2. Gonzalez MW, Kann MG: Chapter 4: Protein interactions and disease. PloS Comput Biol. 2012, 8: 1002819-10.1371/journal.pcbi.1002819.

    Article  Google Scholar 

  3. Laukens K, Naulaerts S, Berghe WV: Bioinformatics approaches for the functional interpretation of protein lists: from ontology term enrichment to network analysis. Proteomics. 2015, 15: 981-996. 10.1002/pmic.201400296.

    Article  CAS  PubMed  Google Scholar 

  4. Glaab E, et al: Enrichnet: network-based gene set enrichment analysis. Bioinformatics. 2012, 28 (18): 451-457. 10.1093/bioinformatics/bts389.

    Article  Google Scholar 

  5. Hung JH, Whitfield TW, Yang TH, Hu Z, Weng Z, DeLisi C: Identification of functional modules that correlate with phenotypic difference: the influence of network topology. Genome Biol. 2010, 11: R23-10.1186/gb-2010-11-2-r23.

    Article  PubMed Central  PubMed  Google Scholar 

  6. Farfán F, et al: THINK Back:KNowledge-based Interpretation of High Throughput data. BMC Bioinformatics. 2012, 13 (Suppl 2): S4-10.1186/1471-2105-13-S2-S4.

    Article  PubMed Central  PubMed  Google Scholar 

  7. Liu L, Ruan J: Network-based Pathway Enrichment Analysis. IEEE International Conference on Bioinformatics and Biomedicine. 2013, 218-221. doi: 10.1109/BIBM.2013.6732493

    Google Scholar 

  8. Dutta , et al: PathNet: a tool for pathway analysis using topological information. Source Code for Biology and Medicine. 2012, 7: 10-10.1186/1751-0473-7-10.

    Article  PubMed Central  PubMed  Google Scholar 

  9. Shojaie A, Michailidis G: Analysis of Gene Sets Based on the Underlying Regulatory Network. J Comp Biol. 2009, 16: 407-426. 10.1089/cmb.2008.0081.

    Article  CAS  Google Scholar 

  10. Cornish AJ, Markowetz F: SANTA: Quantifying the Functional Content of Molecular Networks. PLOS Comp Biol. 2014, 10: e1003808-10.1371/journal.pcbi.1003808.

    Article  Google Scholar 

  11. Tarca AL, et al: A novel signaling pathway impact analysis. Bioinformatics. 2009, 25: 75-82. 10.1093/bioinformatics/btn577.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  12. Winterhalter C, Widera P, Krasnogor N: JEPETTO: a Cytoscape plugin for gene set enrichment and topological analysis based on interaction networks. Bioinformatics. 2014, 30: 1029-1030. 10.1093/bioinformatics/btt732.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  13. Draghici S, et al: A systems biology approach for pathway level analysis. Genome Res. 2007, 17: 1537-1545. 10.1101/gr.6202607.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  14. Jacob L, Neuvial P, Dudoit S: More power via graph-structured tests for differential expression of gene networks. Ann Appl Stat. 2012, 6: 561-600. 10.1214/11-AOAS528. doi:10.1214/11-aoas528

    Article  Google Scholar 

  15. Natale M, Benso A, Di Carlo S, Ficarra E: FunMod: A Cytoscape Plugin for Identifying Functional Modules in Undirected Protein-Protein Networks. Genomics, Proteomics & Bioinformatics. 2014, 12: 178-186. 10.1016/j.gpb.2014.05.002.

    Article  Google Scholar 

  16. Cowley MJ, et al: Pina v2.0: mining interactome modules. Nucl Acids Res. 2012, 40: 862-865. 10.1093/nar/gkr967.

    Article  Google Scholar 

  17. Bessarabova , et al: Knowledge-based analysis of proteomics data. BMC Bioinformatics. 2012, 13 (Suppl 16): S13-

    PubMed Central  CAS  PubMed  Google Scholar 

  18. Kerrien S, et al: IntAct - open source resource for molecular interaction data. Nucleic Acids Res. 2007, 35: 561-565.

    Article  Google Scholar 

  19. Chatr-Aryamontri A, et al: MINT: the Molecular INTeraction database. Nucleic Acids Res. 2007, 35: 572-574. 10.1093/nar/gkl950.

    Article  Google Scholar 

  20. Breitkreutz BJ, et al: The BioGRID interaction database: 2008 update. Nucleic Acids Res. 2008, 36: 637-640.

    Article  Google Scholar 

  21. Salwinski L, et al: The database of interacting proteins: 2004 update. Nucleic Acids Res. 2004, 32: 449-451.

    Article  Google Scholar 

  22. Peri S, et al: Development of human protein reference database as an initial platform for approaching systems biology in humans. Genome Res. 2003, 13: 2363-2371. 10.1101/gr.1680803.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  23. Guldener U, et al: MPact: the MIPS protein interaction resource on yeast. Nucleic Acids Res. 2006, 34: 436-441. 10.1093/nar/gkj451.

    Article  Google Scholar 

  24. Kanehisa M, et al: From genomics to chemical genomics: new developments in KEGG. Nucleic Acids Res. 2006, 34: 354-357. 10.1093/nar/gkj102.

    Article  Google Scholar 

  25. Finn RD, et al: The Pfam protein families database. Nucleic Acids Research. 2014, 42: 222-230. 10.1093/nar/gkt1223.

    Article  Google Scholar 

  26. Ashburner M, et al: Gene ontology: tool for the unification of biology. Nature genetics. 2000, 25: 25-29. 10.1038/75556.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  27. Franceschini A, et al: String v9.1: protein-protein interaction networks, with increased coverage and integration. Nucleic Acids Res. 2013, 41: 808-815. 10.1093/nar/gks1094.

    Article  Google Scholar 

  28. Nishimura D: BioCarta. Biotech Software & Internet Report. 2001, 2 (3): 117-120. 10.1089/152791601750294344.

    Article  Google Scholar 

  29. Pico A, et al: WikiPathways: pathway editing for the people. PLoS Biol. 2008, 6: e184-10.1371/journal.pbio.0060184.

    Article  PubMed Central  PubMed  Google Scholar 

  30. Joshi-Tope G, et al: Reactome: a knowledgebase of biological pathways. Nucleic Acids Res. 2005, 33: D428-

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  31. Schaefer C, et al: PID: the pathway interaction database. Nucleic Acids Res. 2009, 37: D674-10.1093/nar/gkn653.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  32. Apweiler R, et al: The InterPro database, an integrated documentation resource for protein families, domains and functional sites. Nucleic Acids Res. 2001, 29: 37-40. 10.1093/nar/29.1.37.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  33. Online Mendelian Inheritance in Man (OMIM). Retrieved on September 18, 2014, [http://omim.org]

  34. UniProt id mapping data for human proteins. Retrieved on September 8, 2014, [ftp://ftp.uniprot.org/pub/databases/uniprot/current_release/knowledgebase/idmapping/by_organism/HUMAN_9606_idmapping.dat.gz]

  35. Gene ontology hierarchy data file. Generated on September 6, 2014, [http://geneontology.org/ontology/go-basic.obo]

  36. Gene Ontology Annotation database (UniProt-GOA). Generated on September 1, 2014, [http://www.ebi.ac.uk/GOA]

  37. Hwang F, Richards D, Winter P: The Steiner Tree Problem. 1992, Elsevier, Amsterdam

    Google Scholar 

  38. Sadeghi A, Fröhlich H: Steiner tree methods for optimal sub-network identification: an empirical study. BMC Bioinformatics. 2013, 14: 144-10.1186/1471-2105-14-144.

    Article  PubMed Central  PubMed  Google Scholar 

  39. Lin D: An information-theoretic definition of similarity. Proceedings of the 15th International Conference on Machine Learning. Edited by: Kaufmann M. 1998, 296-304.

    Google Scholar 

  40. Freeman L: A set of measures of centrality based on betweenness. Sociometry. 1977, 40: 35-41. 10.2307/3033543.

    Article  Google Scholar 

  41. Testa U: Apoptotic mechanisms in the control of erythropoiesis. Leukemia. 2004, 18: 1176-1199. 10.1038/sj.leu.2403383.

    Article  CAS  PubMed  Google Scholar 

  42. Edden RA, et al: Reduced GABA concentration in attention-deficit/hyperactivity disorder. Arch Gen Psychiatry. 2012, 69: 750-753.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  43. Johansson J, et al: Altered tryptophan and alanine transport in fibroblasts from boys with attention-deficit/hyperactivity disorder (ADHD): an in vitro study. Behav Brain Funct. 2011, 7: 40-10.1186/1744-9081-7-40.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  44. Levine A, et al: Molecular mechanism for a gateway drug: epigenetic changes initiated by nicotine prime gene expression by cocaine. Sci Transl Med. 2011, 3: 107ra109-

    Article  PubMed Central  PubMed  Google Scholar 

  45. Yi SS, Kansagra SM: Associations of sodium intake with obesity, body massindex, waist circumference, and weight. Am J Prev Med. 2014, e53-5. 46

  46. Van der Weerd K, Dik WA, Schrijver B, et al: Morbidly Obese Human Subjects Have Increased Peripheral Blood CD4+ T Cells With Skewing Toward a Treg- and Th2-Dominated phenotype. Diabetes. 2012, 61: 401-408. 10.2337/db11-1065.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  47. Ma H, Patti ME: Bile acids, obesity, and the metabolic syndrome. Best Pract Res Clin Gastroenterol. 2014, 28: 573-83. 10.1016/j.bpg.2014.07.004.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  48. Lowell BB, Bachman ES: Beta-Adrenergic receptors, diet-induced thermogenesis, and obesity. J Biol Chem. 2003, 278: 29385-8. 10.1074/jbc.R300011200.

    Article  CAS  PubMed  Google Scholar 

  49. Wurtman RJ, Wurtman JJ: Brain Serotonin, Carbohydrate-craving, obesity and depression. Adv Exp Med Biol. 1996, 398: 35-41. 10.1007/978-1-4613-0381-7_4.

    Article  CAS  PubMed  Google Scholar 

  50. Gregor MF, Hotamisligil GS: Inflammatory mechanisms in obesity. Annu Rev Immunol. 2011, 29: 415-445. 10.1146/annurev-immunol-031210-101322.

    Article  CAS  PubMed  Google Scholar 

  51. McKnight GS, Cummings DE, Amieux PS, et al: Cyclic AMP, PKA, and the physiological regulation ofadiposity. Recent Prog Horm Res. 1998, 53: 139-59.

    CAS  PubMed  Google Scholar 

Download references

Acknowledgements

We acknowledge the following grants involved in publication of this work: PRIN 2010-2011 project 20108XYHJS (to P.L.M.) (Italian MIUR); COST BMBS Action TD1101 and BM1405 (European Union RTD Framework Program to R.C.); PON projects PON01_02249 and PAN Lab PONa3_00166 (Italian Miur to R.C. and P.L.M.); FARB-UNIBO 2012 (to R.C.).

This article has been published as part of BMC Genomics Volume 16 Supplement 8, 2015: VarI-SIG 2014: Identification and annotation of genetic variants in the context of structure, function and disease. The full contents of the supplement are available online at http://www.biomedcentral.com/bmcgenomics/supplements/16/S8.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Pier Luigi Martelli.

Additional information

Competing interests

The authors declare they have no conflict of interests in relation to this VarISIG issue article.

Authors' contributions

PDL, PLM, PF and RC planned the research and discussed the result; PDL implemented the computational method; PLM and RC analyzed the biological test sets. All the authors contributed to writing and correcting the paper.

Pietro Di Lena, Pier Luigi Martelli contributed equally to this work.

Electronic supplementary material

Additional file 1: Details on the method implementation. (PDF 289 KB)

12864_2015_7220_MOESM2_ESM.pdf

Additional file 2: Figure S1: Number of enriched GO BP terms as a function of the maximum degree of the human proteins annotated with a the same term. (PDF 83 KB)

12864_2015_7220_MOESM3_ESM.tgz

Additional file 3: Detailed results for the OMIM-derived benchmark set. The archive contains pdf documents listing the enriched terms for each one of the 244 diseases in the OMIM-derived benchmark set. (TGZ 7 MB)

Rights and permissions

Open Access  This article is licensed under a Creative Commons Attribution 4.0 International License, which permits use, sharing, adaptation, distribution and reproduction in any medium or format, as long as you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons licence, and indicate if changes were made.

The images or other third party material in this article are included in the article’s Creative Commons licence, unless indicated otherwise in a credit line to the material. If material is not included in the article’s Creative Commons licence and your intended use is not permitted by statutory regulation or exceeds the permitted use, you will need to obtain permission directly from the copyright holder.

To view a copy of this licence, visit https://creativecommons.org/licenses/by/4.0/.

The Creative Commons Public Domain Dedication waiver (https://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated in a credit line to the data.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Di Lena, P., Martelli, P.L., Fariselli, P. et al. NET-GE: a novel NETwork-based Gene Enrichment for detecting biological processes associated to Mendelian diseases. BMC Genomics 16 (Suppl 8), S6 (2015). https://doi.org/10.1186/1471-2164-16-S8-S6

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/1471-2164-16-S8-S6

Keywords