Skip to main content

INBIA: a boosting methodology for proteomic network inference

Abstract

Background

The analysis of tissue-specific protein interaction networks and their functional enrichment in pathological and normal tissues provides insights on the etiology of diseases. The Pan-cancer proteomic project, in The Cancer Genome Atlas, collects protein expressions in human cancers and it is a reference resource for the functional study of cancers. However, established protocols to infer interaction networks from protein expressions are still missing.

Results

We have developed a methodology called Inference Network Based on iRefIndex Analysis (INBIA) to accurately correlate proteomic inferred relations to protein-protein interaction (PPI) networks. INBIA makes use of 14 network inference methods on protein expressions related to 16 cancer types. It uses as reference model the iRefIndex human PPI network. Predictions are validated through non-interacting and tissue specific PPI networks resources. The first, Negatome, takes into account likely non-interacting proteins by combining both structure properties and literature mining. The latter, TissueNet and GIANT, report experimentally verified PPIs in more than 50 human tissues. The reliability of the proposed methodology is assessed by comparing INBIA with PERA, a tool which infers protein interaction networks from Pathway Commons, by both functional and topological analysis.

Conclusion

Results show that INBIA is a valuable approach to predict proteomic interactions in pathological conditions starting from the current knowledge of human protein interactions.

Background

The understanding of the cell behavior and the characterization of the human tissues relies on both experimental and advanced information technologies. The release of The Cancer Proteome Atlas (TCPA) has provided proteomic expression data for 190 proteins in 16 cancer types using reverse-phase protein arrays (RPPA) technology [1]. This technique is able to measure hundreds of protein expression levels in many cancer tissues and makes possible the study of their differences and commonalities.

TCPA dataset contains phosphoproteins which provides information about the role of post-translational modifications (PTMs) such as phosphorylation in cancer. Other common PTMs include methylation and ubiquitination [2]. In general, these modifications affect the cellular processes by regulating protein-protein interactions (PPIs) being a remarkable key component in cell signaling, especially when dealing with cancer cells [3].

Extracting valuable information from proteomic data relies on the prediction and the analysis of their interactions. In this direction, network inference methods are widely used mainly on gene expression data. In [4], authors have gone beyond by proposing protein interactions inference, on 11 human cancers. For this purpose they used as reference model for existing interactions curated biochemical pathways stored in Pathway Commons [5]. However, pathways mostly do not contain direct protein interactions. Therefore authors infer such interactions by using Prior Extraction and Reduction Algorithm by specifying the distance of the shortest path that has to exist between two proteins within a pathway in order to consider those two proteins as interacting. Reference models are usually referred as gold standards. In this paper we propose a method called Inference Network Based on iRefIndex Analysis (INBIA), to infer protein-protein interaction networks from proteomic data, that attempts to overcome some of the limitations reported in [4]. More precisely, we overtake the bias in the knowledge base and the lack of context information for PPIs by considering iRefIndex [6] as gold standard for PPI networks inference [7]. iRefIndex is a consolidated database, which accurately integrates non-redundant PPIs from several sources by taking into account protein sequences and taxonomy [6]. We used 16 tissues data from TCPA and a set of 14 inference methods based on correlation, partial correlation, mutual information, and regression. The statistical correlation between protein expressions has important biological pros and cons because it may entail direct or indirect interactions [7], where the latter represents paths of pairwise directly connected proteins. Direct and indirect interactions may represent models of signal transduction, innate and adaptive immune signaling, cell cycle, metabolism, and DNA repair process.

We evaluated INBIA by comparing it with the method presented in [4], called PERA, in terms of true positive and true negative rates of inferred interactions considering both direct and indirect interactions. For each cancer type, we established the best performing methods. Moreover, we constructed predicted networks by assembling the most accurate results and associating consensus weights to interactions.

We evaluated the accuracy of predicted networks by annotating them in Negatome [8], and by comparing them with the tissue-specific PPI networks retrieved from TissueNet [9] and GIANT [10]. We also provide the functional and topological analyses of these networks, by reporting the different patterns of mutated genes and characterizing their diversities. Analyses showed that INBIA is a valuable resource to predict proteomic interactions in new pathological conditions starting from the current knowledge of human protein interactions.

Methods

Datasets

We downloaded data from TCPA [11] containing RPPA expressions of 190 proteins and phosphoproteins over 16 different cancer types (See Additional file 1: Table S1). The RPPA technology is similar to microarray for gene expression meaning that it can measure many proteins at the same time, but conversely it is based on specific and high-quality antibodies. Each cancer-related dataset has a different number of samples. Datasets are normalized by applying loading control for most of the tissues, whereas replicates based normalization is applied for BRCA, SKCM and THCA[1]. The normalization in RPPA dataset is needed because, like the western blot technique, each sample has different features such as cell number and membrane transfer efficiency. The loading control is a biological normalization procedure that relies on the quantification through specific antibody of another protein in order to compare their relative amount[12, 13].

The prediction of true interactions largely depends on the chosen gold standard. We use iRefIndex [6] as comprehensive and non redundant resource.

It includes 673,100 interactions covering proteins belonging to human and other species. Among these PPIs, we selected those having HGNC approved gene nomenclature. We mapped each protein to the corresponding gene symbol removing redundant interactions. Finally, we obtained a network with 179,387 interactions and 15,498 gene symbols. Then, we extracted the induced iRefIndex network by TCPA gene set such that each node in the network is a gene symbol within TCPA gene set. In the rest of the paper, we simply name it as iRefIndex network or gold standard. INBIA gold standard contains 148 nodes and 972 edges.

Inference network based on iRefIndex analysis-INBIA pipeline

INBIA relies on the selection of a subset of best performing methods made through comparisons with the gold standard. Figure 1 depicts INBIA methodology to infer protein network interactions from TCPA proteomic expressions for 16 cancers tissues (details on data are reported in Results and discussion Section). INBIA applies the 14 methods (See Fig. 1(a) and Additional file 1: Table S2), using their default parameters.

Fig. 1
figure 1

Inference Network Based on iRefIndex Analysis (INBIA) pipeline. We selected 14 inference methods and applied them to the 16 RPPA datasets in order to achieve PPI predictions (a). Networks are inferred following two approaches: (i) the predictions have been compared with the gold standard, iRefIndex, in order to obtain true positive (TP), false positive (FP), true negative (TN) and false negative (FN) values from which it was computed F-measure, a weighted combination of precision and recall (b). The best method for each cancer type was selected and its associated network was returned (c); (ii) for each cancer type, an ensemble network was created by computing all possible PPIs generated from genes associated to TCPA proteins and then a score from the ensemble of best methods (BM) that represents the percentage of BMs within the ensemble which have predicted that PPI (d). The methods named M1, M2, …M14 correspond to those reported in Additional file 1:Table S2

Following the Dialogue on Reverse Engineering Assessment and Methods (DREAM) Challenge for gene regulatory network inference [14], we classified the methods into four main classes: correlation/partial correlation, linear regression and mutual information[7] (Table 1). Results have been then filtered according to the significance of the method’s predictions. In particular, for each predicted protein-protein edge a p-value, based on Graphical Gaussian Model [15], is computed. For methods based on mutual information we applied their own criterion to filter false positive interactions and maintained only those with scores greater than 0. For all the remaining methods, only predicted interactions with p-value less than 0.05 have been selected.

Table 1 Inference methods used to retrieve predictions on PPI from cancer tissues grouped by category

For each inferred network, INBIA measures the goodness of predictions starting from the computation of true positive and false positive rates with respect to the gold standard. After the execution of each inference algorithm, INBIA collects the most significant results and measures these values. The True Positives (TP) are all the predicted interactions that are present in the gold standard. True Negatives (TN) are the interactions that are not predicted by the method and are not present in the gold standard. False Positives (FP) are the predicted interactions that are not present in the gold standard. Finally, False Negatives (FN) are the edges in gold standard that are not obtained by the method. The Precision is then defined as the ratio of TP over the sum of TP and FP. Recall is the ratio of TP over the sum of TP and FN. The efficiency of the methods is established by combining precision and recall into the F-measure:

$$ {F-measure} = 2 \cdot \frac{precision \cdot recall}{precision + recall} $$
(1)

From each inferred network, we built three more networks in the following way: for each pair of nodes not connected by a direct edge, we computed indirect interactions by searching for paths of length k within the gold standard, for k=2,3,4, respectively. Such interactions are referred as indirect. From now on we will only refer to inferred networks with direct edges (i.e., k=1).

For each cancer type, INBIA infers networks by applying the 14 methods and choosing as result the network with higher value of F-measure (Fig. 1(b)(c)). The method which generates such network is named ’best method’. Once the best method has been established for each of the 16 cancer tissues, an ensemble network, for each cancer type, is built by taking into account all networks inferred by the best methods (Fig. 1(d)). INBIA creates complete networks whose nodes are TCPA genes and all possible edges among them exist. Then it assigns scores to edges, initially set to zero. Scores represent how many methods have predicted the edges. At the end, edges with score zero are removed from the network. Unless differently specified, we refer as INBIA inferred networks those obtained by the best methods and not through the ensemble computation.

INBIA validation

Comparison with pathway commons PPI network

The selection of a good gold standard for human PPI network inference affects the quality of the results. We also created a gold standard of protein interactions network from Pathway Commons v2 as presented in [4]. We selected the ontology contained in the file Pathway Commons all.BIOPAX.owl and downloaded bp_prior v2.9.1 that implements Prior Extraction and Reduction Algorithm (PERA) (https://bitbucket.org/armish/bp/_prior).

PERA accepts as input a list of proteins together with their post-translational modifications status and a file containing pathways in BioPAX format. We downloaded the input list provided in the supplementary files of [4]. Such list contains only TCPA proteins with related official gene symbols and associated PTMs. PERA produced as output a list of direct or indirect (with mediating proteins) PPIs found within the pathways relative to genes provided in input. The parameters –graph-limit and –site-tolerance were set to 1 and 3, respectively, for direct interactions. Proteins were converted with official gene symbols achieving 790 unique interactions (See Additional file 2). We ran the INBIA pipeline by using as gold standard the Pathway Commons resource as described above. We then compared the results with the original INBIA pipeline which uses iRefIndex. For sake of simplicity, we simply refer to the pipeline based on Pathway Commons as PERA.

Topology-based analysis

Inferred networks were compared with online resources in order to assess their quality in terms of corrected tissue specific predicted interactions. Negatome 2.0 [8] reports likely non interacting proteins based on literature mining and protein structures from Protein Data Bank (PDB)[16]. This dataset is useful to evaluate the number of false positives in predicting the PPIs. Negatome distinguishes between PDB and manually derived data or combines them in order to create a unique resource. We chose the latest stringent solution containing 6,136 PPIs with UniProt symbols subsequently converted in a total of 5,386 likely non-interacting proteins with official gene symbols.

TissueNet v.2 [9] and GIANT [10] contain functional interaction networks for several human tissues. In particular INBIA uses TissueNet, a database of tissue specific networks obtained from HPA protein expression (Human Protein Atlas). GIANT is based on a Bayesian methodology to integrate data from genome experiments and disease conditions. GIANT classifies, for each tissue, the edges into four classes C1-C4. C1 contains interactions among tissue specific genes positively co-expressed in the tissues, C2 contains interactions among tissue specific genes and multi-tissues genes positively co-expressed. C3 and C4 are the negative-co-expressed counterparts of C1 and C2, respectively. Validation was carried out by choosing key-words such that cancer tissues matched normal counterparts. Trustfulness on edges prediction relies on the edges’s presence in TissueNet, in C1 and C2 GIANT classes, and their absence in Negatome. In order to evaluate the reliability of INBIA in predicting tissue specific networks from new pathological conditions, by using the ensemble networks and tissue specific PPI networks from TissueNet, we computed precision-recall (PR) curves with the R package ROCR [17]. We performed a topological analysis of the INBIA and PERA inferred networks, by making a functional annotation of their nodes and by looking for small network motifs in the annotated networks. A network motif is a subgraph of the target network which occurs more frequently than expected with respect to a random network model [14, 18, 19]. The topological information of motifs may provide insights on the main processes involving specific tissues and may help to identify the main active pathways. Moreover, predicted PPIs within recurrent motifs may be present or not across the inference methods, thus being putative biomarkers to look at. We ran FlashMotif algorithm [20] to find all possible non-induced colored motifs of 3 and 4 nodes, where a motif represents a subgraph in which each node is ‘colored‘ with a specific GO term. We used BiNGO [21] to annotate nodes of INBIA and PERA inferred networks with one or more of the following Gene Ontology terms: phosphorylation (GO:0016310), cell death (GO:0008219), signaling (GO:0023052) and cell proliferation (GO:0008283). Proteins linked to none of the previous GO terms were annotated with the generic ‘biological process‘ GO term (GO:0007582). We decided to focus only on non-induced motifs because the number of non-induced occurrences of a motif is less sensitive to the presence of false positive interactions in a network, so the non-induced definition is more suitable than the induced one for PPI networks [22]. Since a node can be associated with two or more GO terms and FlashMotif only works with graphs where each node is mapped with a unique color, we therefore re-structured the networks, before running FlashMotif. In particular, if a node had n associated GO terms we created n copies of the node together with n copies of its links to the other nodes in the network. Replicating nodes and edges is necessary to avoid loosing network information and underestimating the number of occurrences of labeled motifs.

Functional analysis

The functional enrichment of predicted interactions was carried out using Molecular Signature Database v5.2 (MSigDB) for gene set enrichment analysis [23]. Overlaps with MSigDB gene sets were computed by selecting the top 10 with false discovery rate less than 0.05 within hallmark gene sets which yield precise biological functions relationships and contain genes with similar expression patterns.

The gene mutation analysis of interacting proteins was performed using Catalogue Of Somatic Mutations In Cancer (COSMIC) v80 [24], in particular we used the information contained in the cancer gene census. For each cancer type, the proteins contained in the PPI networks were extracted and annotated with COSMIC data considering somatic and germline mutations.

Results and discussion

We analyzed the performance of INBIA and PERA by measuring the biological soundness of the inferred networks together with their functional annotation with cancers. Additional file 1: Table S3, summarizes the topological properties of the inferred networks while the measures are reported in Additional file 3. We computed Wilcoxon rank-sum test, using the package stats in R, in order to verify if the networks produced by INBIA and PERA were significantly different based on their network properties (See Additional file 1: Table S3, along with p-values produced by the statistical test). As the p-values were never less than 0.05, we could not rejected the hypothesis, therefore, we concluded that networks were comparable. Intuitively, the difference in the number of interactions is due to the nature of the resources used by iRefIndex and Pathway Commons and their curation. iRefIndex is made of a large number of interactions. However, this may be a drawback since it could increase the number of false positive in the networks inferred for each cancer type. We will verify this aspect, i.e. the accuracy of obtained computational protein interactions, by using further validation procedures.

Table 2 reports the F-measures of the best methods of INBIA and PERA. Additional file 1: Table S4, reports also the F-measures for indirect interactions. From the best methods, we computed tissue-specific precision and recall (PR) curves by using the ensemble inference networks for both approaches (Fig. 2). INBIA’s ensemble set is made by 4 methods (CLR, GLASSO, PLS, and MRNET), while PERA’s best methods are: ELASTICNET, PLS, ARACNE, SPEARMAN, WGCNA, and CLR. Tissue specific networks from TissueNet are used as gold standards to compute PR curves. PR curves assess the goodness of INBIA and PERA in inferring pathological networks starting from the ensemble scores assigned to PPIs. For all cancers, INBIA performs better than PERA even if, for some tissues, the difference between the curves is reduced. INBIA’s precision is constant at 0.4 on average until recall reaches 0.7, then it decreases to a value less than 0.1 when recall is maximum. It achieves the best results for BLCA and SKCM. This trend can be associate to a PR curve of a good classifier meaning that the predictions of INBIA based on iRefIndex are more accurate compared to those of PERA based on Pathway Commons.

Fig. 2
figure 2

Network prediction quality based on tissue specificity. Precision-recall curves of INBIA’s (orange line) and PERA’s performances (blue line) in predicting tissue-specific PPIs. Each plot refers to a specific cancer type. The performances were computed by considering the ensemble scores generated from INBIA’s and PERA’s best methods and the TissueNet counterparts as ground truth (see Additional file 1: Table S5)

Table 2 Cancer types and best performing inference network methods with maximum F-measure value

Networks obtained from the best methods for both PERA and INBIA were compared with two datasets in order to assess their quality in terms of corrected predicted interactions (Table 3). We associates TCPA cancer tissues and related genes to normal counterparts, from online resources, by considering the incidence of each pathology in normal tissues (See Additional file 1: Table S5). Comparing with Negatome, we found that there was, in all cases and for both methods, a very small set of interactions in common, meaning that both methods predicted few validated false negative interactions. However, the percentage of overlapping interactions of our method is lower compared to that of PERA. As reported in Table 3 and Additional file 1: Table S6, compared to PERA, INBIA predicts a larger statistically significant amount of tissue specific protein interactions present in TissueNet (p-value <0.001 by using T-test).

Table 3 Comparisons with Negatome and TissueNet by considering cancer types and normal counterparts (see Additional file 1: Table S5). The overlap is reported in percentage with respect to the number of total unique predictions per cancer/tissue. For each tissue, we report in the first row the percentage of INBIA’s overlapping, while in the second PERA’s one

Figure 3 reports the PPI predictions present in tissue specific networks from GIANT. INBIA and PERA maintain the same trend: the majority of predictions belong to classes C1 and C2, with some exceptions that show small amounts of PPI in C3, and C4 classes. Once again, the amount of predictions predicted of INBIA is larger than PERA but the differences in this case has a weak statistical significance (p-value = 0.06 by using T-test). Concerning motif analysis, FlashMotif took about 4 minutes to retrieve all colored motifs with 3 and 4 nodes in all the 16 INBIA and PERA tissue-specific networks. The algorithm found 959 colored motifs with 3 nodes and 9,006 motifs with 4 nodes in INBIA networks. In PERA networks, FlashMotif found 798 motifs with 3 nodes and 5,489 motifs with 4 nodes. However, very few of them were significantly over-represented (p-value ≤ 0.05). FlashMotif found just 7 over-represented motifs with 4 nodes in the INBIA network. In PERA network, 38 motifs with 3 nodes and 903 motifs with 4 nodes were over-represented. The higher number of over-represented motifs found in PERA networks is mainly due to the fact that these networks are sparser than INBIA ones. Notwithstanding, interestingly, all 7 over-represented motifs with 4 nodes found in INBIA networks are also over-represented motifs in PERA networks. Table 4 lists these motifs and, for each motif, it reports the tissue where the motif is over-represented, the number of occurrences, and relative p-values. The 7 over-represented motifs found are examples of ‘diamonds’, which are common in signal-transduction networks, because they are related to modifications such as phosphorylation [25]. So, motif analysis shows that protein-protein interactions of networks inferred by INBIA are biologically significant. We computed the predicted PPIs in common among all inferred networks (See Additional file 1: Figure S1). Each node size in the INBIA’s and PERA’s network corresponds to collective influence and nodes are colored in red if they belong to MDS. INBIA graph has one large connected component. The graph produced for PERA has 5 small components. According to INBIA results we can speculate that a core module may be preserved in different cancers. The list of all edges found with this analysis is reported in Additional file 4. We investigated the role of genes in the inferred networks by considering the Oncopanel, a custom targeted next-generation sequencing assay for cancer [26]. We found a core module containing 15 genes that overlap with OncoPanel (See Additional file 1: Figure S2). Moreover, for each cancer type, the best PPI inference networks related to OV, BRCA, UCEC, STAD and KIRC achieved the highest number of genes (33, 28, 27, 26, 24, respectively) that overlap with OncoPanel. The complete results are reported in Additional file 5. Minimum dominating sets (MDS) [27] and collective influence of nodes (See Additional file 1: Section 3 for the definition) for each inferred network by INBIA and PERA are reported in Additional file 6. INBIA unravels a total of 83 PPIs that includes EIF4EBP1, AKT1, GSK3A, RPS6, MAPK1, SRC proteins as most central in the network based on computed collective influence centrality measure [28]. PERA achieves 12 common PPIs in which the main central nodes are TSC2, AKT1 and GSK3A.

Fig. 3
figure 3

Comparison of predicted PPI classes in GIANT. The plots show comparison between INBIA and PERA best methods for each cancer type and relative amount of predicted PPIs that fall within each GIANT class. PPIs in C1-C2 represent functionally related pairs in the same tissue (C1) or in multi-tissues (C2), conversely C3-C4 are likely functionally unrelated pairs. For HNSC no overlaps were found, meaning that both methods cannot predict the interactions provided by GIANT

Table 4 Common over-represented motifs found in INBIA and PERA networks inferred from best methods. For each motif, the number of occurrences and relative p-values in INBIA and PERA networks are reported (CD = Cell Death, CP = Cell Proliferation, P = Phosphorylation, S = Signaling)

Additional file 1: Table S7, reports the enrichment of the genes present in the whole TCPA dataset. Figure 4 shows the enriched gene sets from MSigDB [23] for INBIA and PERA. The analysis was carried out by using PPIs predicted from best methods for each cancer type, as reported in Table 2. Note that each network does not contain all TCPA proteins, since only nodes with predicted interactions belong to the network. The x-axis contains the number of genes overlapping with each gene set while the y-axis represents the enriched gene sets. HALLMARK_PI3K_AKT_MTOR_SIGNALING always contains the majority of genes for all tissues both for INBIA and PERA. The latter in general predicts less PPIs and this can be seen in the smaller number of overlapping genes. INBIA’s best networks produce specific gene sets, e.g. HALLMARK_MTORC1_SIGNALING, that are not present in PERA’s results. Conversely, HALLMARK_INFLAMMATORY_RESPONSE or HALLMARK_TNFA_SIGNALING_VIA_NFKB are not among gene sets enriched from INBIA.

Fig. 4
figure 4

Gene Set enrichment analysis. The plot represents the most enriched gene sets for each cancer type. For each type, the best methods predictions based on INBIA and PERA were retrieved and the gene symbols corresponding to the predicted PPIs were enriched by using MSigDB. The x-axis contains the hallmark gene sets for each method while y-axis reports the gene symbols k that overlaps with hallmark gene sets, reported in the legend with different colors

Table 5 reports the genes inferred by INBIA and PERA annotated in COSMIC. Once again, our method, in general, infers more mutated genes associated with specific cancers.

Table 5 COSMIC mutation analysis by considering genes related to PPIs predicted from best methods in our and PERA approaches and the relative amount of somatic and germline mutated genes

Conclusions

In this paper we aimed to understand and therefore overcome some of the limitations affecting the performances of network inference methods. We proposed a methodology for protein-protein interaction network prediction from proteomic data, called Inference Network Based on iRefIndex Analysis (INBIA). INBIA consists of several inference methods based on correlation, partial correlation, mutual information and regression. It uses as gold-standard protein interaction networks (iRefIndex). The reliability of our approach is assessed on a set of tissue-specific PPI networks built on top of TCPA data. We compared INBIA with PERA [4], which instead relies on Pathway Common database as gold-standard. The results show that our approach is capable to recover better PPI interaction networks, in terms of precision-recall, with respect to those retrieved by PERA when compared on TissueNet [9]. Furthermore, a comparison of the inferred networks using GIANT tissue/edges classification shows that INBIA networks contain more interactions among tissue specific genes positively co-expressed in the tissue. Moreover, INBIA retrieves interactions involving a larger set of known cancer mutated genes and networks contain significantly expressed motifs. INBIA results show a consistent core module of interactions preserved in different cancers, composed of topological significant nodes, i.e. with high collective influence and belonging to minimum dominating sets. On the other hand both INBIA and PERA return very few false positive interactions with respect to the Negatome. Therefore, the comparison clearly highlights that the selection of a proper reference database is crucial to establish the actual soundness of inference network models.

Abbreviations

DPI:

Data processing inequality

PPI:

Protein-protein interaction

PTM:

Post-translational modification

RPPA:

Reverse-phase protein array

References

  1. Akbani R, Ng P, Werner H, Shahmoradgoli M, Zhang F, Ju Z, Liu W, Yang J-Y, Yoshihara K, Li JEA. A pan-cancer proteomic perspective on the cancer genome atlas. Nat Commun. 2014;5(3887). https://doi.org/10.1038/ncomms4887.

  2. Khoury G, Baliban R, Floudas C. Proteome-wide post-translational modification statistics: frequency analysis and curation of the swiss-prot database. Sci Rep. 2011;1(90). https://doi.org/10.1038/srep00090.

  3. Krueger KE, Srivastava S. Posttranslational protein modifications current implications for cancer detection, prevention, and therapeutics. Mol Cell Proteomics. 2006; 5(10):1799–810.

    Article  PubMed  CAS  Google Scholar 

  4. Şenbabaoğlu Y, Sümer S, Sánchez-Vegaet F, Bemis D, Ciriello G, Schultz N, Sander C. A multi-method approach for proteomic network inference in 11 human cancers. PLOS Comput Biol. 2016; 12:1–31.

    Article  Google Scholar 

  5. Cerami E, Gross B, Demir E, Rodchenkov I, Babur O, Anwar N, Schultz N, Bader G, Sander C. Pathway commons, a web resource for biological pathway data. Nucleic Acids Res. 2011; 39(Suppl.1):685–90.

    Article  CAS  Google Scholar 

  6. Razick S, Magklaras G, Donaldson I. irefindex: A consolidated protein interaction database with provenance. BMC Bioinformatics. 2008; 9(1):405.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  7. Sardina DS, Micale G, Ferro A, Pulvirenti A, Giugno R. Correlation between proteomic network inference and protein-protein interaction networks. In: Proc. 13th International Conferenceon on Computational Intelligence Methods for Bioinformatics and Biostatistics. Stirling: Computing Science and Mathematics, Faculty of Natural Sciences, University of Stirling Ⓒ 2016 Andrea Bracciali: 2016. p. 39–44.

    Google Scholar 

  8. Blohm P, Frishman G, Smialowski P, Goebels F, Wachinger B, Ruepp A, Frishman D. Negatome 2.0: A database of non-interacting proteins derived by literature mining, manual annotation and protein structure analysis. Nucleic Acids Res. 2014; 42:396–400.

    Article  CAS  Google Scholar 

  9. Basha O, Ruth B, Sharon M, Lerman E, Kirson B, Hekselman I, Yeger-Lotem E. The tissuenet v.2 database: A quantitative view of protein-protein interactions across human tissues. Nucleic Acids Res. 2016; 45:427–31.

    Article  CAS  Google Scholar 

  10. Greene CS, Krishnan A, Wong AK, Ricciotti E, Zelaya RA, Himmelstein DS, Zhang R, Hartmann BM, Zaslavsky E, Sealfon SC, et al. Understanding multicellular function and disease with human tissue-specific networks. Nat Genet. 2015; 47(6):569–76.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  11. Li J, Lu Y, Akbani R, Ju Z, Roebuck PL, Liu W, Yang J-Y, Broom BM, Verhaak RG, Kane DWEA. Tcpa: a resource for cancer functional proteomics data. Nat Methods. 2013; 10(11):1046–7.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  12. Wachter A, Bernhardt S, Beissbarth T, Korf U. Analysis of reverse phase protein array data: from experimental design towards targeted biomarker discovery. Microarrays. 2015; 4(4):520–39.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  13. Liu W, Ju Z, Lu Y, Mills G. B, Akbani R. A comprehensive comparison of normalization methods for loading control and variance stabilization of reverse-phase protein array data. Cancer Inform. 2014; 13:109.

    PubMed  PubMed Central  CAS  Google Scholar 

  14. Marbach D, Costello J, Küffner R, Vega N. M, Prill R, Camacho D, Allison K, Kellis M, Collins J, Stolovitzky GEA. Wisdom of crowds for robust gene network inference. Nat Methods. 2012; 9(8):796–804.

    Article  PubMed  PubMed Central  CAS  Google Scholar 

  15. Schäfer J, Strimmer K. An empirical bayes approach to inferring large-scale gene association networks. Bioinformatics. 2005; 421(6):754–64.

    Article  Google Scholar 

  16. Kouranov A, Xie L, de la Cruz J, Chen L, Westbrook J, Bourne P, Berman H. The rcsb pdb information portal for structural genomics. Nucleic Acids Res. 2006; 34(suppl 1):302–5.

    Article  CAS  Google Scholar 

  17. Sing T, Sander O, Beerenwinkel N, Lengauer T. Rocr: visualizing classifier performance in r. Bioinformatics. 2005; 21(20):3940–1.

    Article  PubMed  CAS  Google Scholar 

  18. Bonnici V, Busato F, Micale G, Bombieri N, Pulvirenti A, Giugno R. APPAGATO: an APproximate PArallel and stochastic GrAph querying TOol for biological networks. Bioinformatics. 2016; 32(14):2159–66.

    Article  PubMed  CAS  Google Scholar 

  19. Micale G, Ferro A, Pulvirenti A, Giugno R. Spectra: an integrated knowledge base for comparing tissue and tumor-specific ppi networks in human. Front Bioeng Biotechnol. 2015; 3:1–15.

    Article  Google Scholar 

  20. Micale G, Giugno R, Ferro A, Mongiovì M, Shasha D, Pulvirenti A. Fast analytical methods for finding significant labeled graph motifs. Data Mining Knowl Discov. 2017; 32:1–28. https://doi.org/10.1007/s10618-017-0544-8.

    Google Scholar 

  21. Maere S, Heymans K, Kuiper M. Bingo: a cytoscape plugin to assess overrepresentation of gene ontology categories in biological networks. Bioinformatics. 2005; 21(16):3448–9.

    Article  PubMed  CAS  Google Scholar 

  22. Alon N, Dao P, Hajirasouliha I, Hormozdiari F, Sahinalp SC. Biomolecular network motif counting and discovery by color coding. Bioinformatics. 2008; 24(13):241. https://doi.org/10.1093/bioinformatics/btn163.

    Article  CAS  Google Scholar 

  23. Subramanian A, Tamayo P, Mootha V, Mukherjee S, Ebert B, Gillette M, Paulovich A, Pomeroy S, Golub T, Lander E, Mesirov J. Proc Natl Acad Sci U S A. 2005; 102(43):15545–50.

  24. Forbes SA, Bindal N, Bamford S, Cole C, Kok CY, Beare D, Jia M, Shepherd R, Leung K, Menzies A, et al. Cosmic: mining complete cancer genomes in the catalogue of somatic mutations in cancer. Nucleic Acids Res. 2010; 929:D945–50. https://doi.org/10.1093/nar/gkq929.

    Google Scholar 

  25. Alon U. Network motifs: theory and experimental approaches. Nat Rev Genet. 2007; 8(6):450–61. https://doi.org/10.1038/nrg2102.

    Article  PubMed  CAS  Google Scholar 

  26. Garcia EP, Minkovsky A, Jia Y, Ducar MD, Shivdasani P, Gong X, Ligon AH, Sholl LM, Kuo FC, MacConaill LE, Lindeman NI, Dong F. Validation of oncopanel a targeted next-generation sequencing assay for the detection of somatic variants in cancer. Arch Pathol Lab Med. 2017; 141(6):751–8. https://doi.org/10.5858/arpa.2016-0527-OA.

    Article  PubMed  Google Scholar 

  27. Ruan L, Du H, Jia X, Wu W, Li Y, Ko K. A greedy approximation for minimum connected dominating sets. Theor Comput Sci. 2004; 329(1-3):325–30.

    Article  Google Scholar 

  28. Morone F, Makse H. Influence maximization in complex networks through optimal percolation. Nature. 2015; 524:65–8.

    Article  PubMed  CAS  Google Scholar 

Download references

Funding

The publication cost of this article was funded by Fondo Unico Ricerca (FUR) and INDAM - GNCS Project 2017.

Availability of data and material

The datasets used and analysed are available from TCPA, INBIA methodology is downloadable from GitHub.

About this supplement

This article has been published as part of BMC Bioinformatics Volume 19 Supplement 7, 2018: 12th and 13th International Meeting on Computational Intelligence Methods for Bioinformatics and Biostatistics (CIBB 2015/16). The full contents of the supplement are available online at https://bmcbioinformatics.biomedcentral.com/articles/supplements/volume-19-supplement-7.

Publishers Note

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

Author information

Authors and Affiliations

Authors

Contributions

All authors have read and approved final manuscript.

Corresponding author

Correspondence to Rosalba Giugno.

Ethics declarations

Ethics approval and consent to participate

Not applicable.

Competing interests

The authors declare that they have no competing interests.

Additional files

Additional file 1

Supplementary Materials. (PDF 1120 kb)

Additional file 2

PERA PPI gold standard network created from Pathway Commons v2. (XLSX 19 kb)

Additional file 3

Inferred PPIs network statistics and p-values computed with Wilcoxon rank-sum test for each cancer type. (XLSX 14.9 kb)

Additional file 4

Methods and cancers consensus PPI networks for INBIA and PERA. (XLSX 15.4 kb)

Additional file 5

Genes present in OncoPanel that overlap with TCPA, INBIA consensus network and INBIA cancer-specific best PPI networks. (XLSX 18.3 kb)

Additional file 6

Minimum dominating set and corresponding collective influence measure as computed within each cancer’s best method network for INBIA and PERA. (XLSX 49 kb)

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

Sardina, D., Micale, G., Ferro, A. et al. INBIA: a boosting methodology for proteomic network inference. BMC Bioinformatics 19 (Suppl 7), 188 (2018). https://doi.org/10.1186/s12859-018-2183-5

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/s12859-018-2183-5

Keywords