Skip to main content

Phylo_dCor: distance correlation as a novel metric for phylogenetic profiling

Abstract

Background

Elaboration of powerful methods to predict functional and/or physical protein-protein interactions from genome sequence is one of the main tasks in the post-genomic era. Phylogenetic profiling allows the prediction of protein-protein interactions at a whole genome level in both Prokaryotes and Eukaryotes. For this reason it is considered one of the most promising methods.

Results

Here, we propose an improvement of phylogenetic profiling that enables handling of large genomic datasets and infer global protein-protein interactions. This method uses the distance correlation as a new measure of phylogenetic profile similarity. We constructed robust reference sets and developed Phylo-dCor, a parallelized version of the algorithm for calculating the distance correlation that makes it applicable to large genomic data. Using Saccharomyces cerevisiae and Escherichia coli genome datasets, we showed that Phylo-dCor outperforms phylogenetic profiling methods previously described based on the mutual information and Pearson’s correlation as measures of profile similarity.

Conclusions

In this work, we constructed and assessed robust reference sets and propose the distance correlation as a measure for comparing phylogenetic profiles. To make it applicable to large genomic data, we developed Phylo-dCor, a parallelized version of the algorithm for calculating the distance correlation. Two R scripts that can be run on a wide range of machines are available upon request.

Background

In the last two decades, several computational approaches have been proposed to infer both functional and physical protein-protein interactions (PPIs). These methods includes the identification of gene fusion events [1, 2], conservation of gene neighborhood [3] or phylogenetic profiling [4, 5]. Recently, the increasing number of fully sequenced genomes led to a renewed interest in these approaches. Among them, the phylogenetic profiling is one of the most promising in that it allows to predict protein-protein interactions at a whole genome level, while gene fusion and gene neighborhood are relatively rare events found typically in prokaryotic genomes.

Well implemented methods, based on phylogenetic profiling, have been developed and successfully applied for understanding relationships between proteins and/or to gain insights on the function of uncharacterized proteins [see for example [68]. These methods are based on the detection of orthologs either from sequence similarity score or from tree-based algorithms (for a recent implementation see [9]).

In general, phylogenetic profiling is based on the assumption that proteins involved in the same biological pathway or in the same protein complex co-evolve [for a review see [10]. In a first implementation [4], the phylogenetic profile of a protein was defined as a binary vector that describes the occurrence pattern of orthologs in a set of fully sequenced genomes, and the Hamming distance was used to score the similarity between profile pairs. Subsequently, to evaluate different degrees of sequence divergence, phylogenetic profiles were reconstructed using probabilities derived by the expectation values obtained aligning the proteins under study with a genome reference set [5]. Among measures proposed to score the phylogenetic profile similarities [for a review see [11], the Mutual Information (MI) was demonstrated to correlate well in accuracy with genome-wide yeast two-hybrid screens or mass spectrometry interaction assays [5]. Although it was largely adopted as a measure of phylogenetic profile similarity, Simon and Tibshirani recently debated about the lower power of MI in detecting dependency between two variables compared with correlation measures [12].

In this work, we propose the distance correlation (dCor) as a novel metric to score phylogenetic profile similarity. dCor measures any dependence between two variables, ranges between 0 and 1, and it satisfies all requirements of a distance [13, 14].

In order to apply this measure to large genomic data, we developed a novel parallel version of the original algorithm. Furthermore, we adopted a new strategy of genome selection to obtain unbiased and large reference sets of genomes. We applied this methodology to construct phylogenetic profiles of two model organisms, Escherichia coli and Saccharomyces cerevisiae and confirmed that correlation measures (dCor and Pearson’s correlation) have a more robust predictive performance than the MI. In particular we showed that dCor performs better than Pearson’s correlation (PC) and MI especially in predicting physical protein-protein interactions.

Implementation

Phylogenetic profiling

Phylogenetic profiles were obtained as arrays of probability values according to

$$ \boldsymbol{P}=-1/{\boldsymbol{log}}_{10}\left(\boldsymbol{E}\right) $$

For E-values higher than 10−1, the probability value is set to 1, as proposed in [5].

Where E are the E-values obtained from the alignments of S. cerevisiae and E. coli protein sequences against the four reference sets. To do this, we applied the Smith-Watermann alignment algorithm [15]. The FASTA package version 36 was implemented as a stand-alone software on two Work Stations both dual core, the first with 12 CPU and the second with 8 CPU.

Similarity measures

One of the method usually used to establish similarity between phylogenetic profiles is the mutual information that is calculated according to

$$ MI\left(A,B\right)=H(A)+H(B)-H\left(A,B\right) $$

where H(A) =  −  ∑ p(a) ln p(a) is the summation of the marginal entropies, calculated over the intervals of probability distribution p(a), of the gene A to occur among the organisms in the reference set. H(A, B) =  −  ∑  ∑ p(a, b) ln p(a, b)represents the summation of the relative entropies of the joint probability distribution p(a, b)of co-occurrence of gene A and B across the set of reference genomes, in the intervals of the probability distribution. The mutual information was calculated by using the mutualInfo function available in bioDist R package [16] after binning the data into 0.1 intervals.

We calculated dCor according to Szekely and collaborators [13, 14]. The original implementation (available in the energy package of Bioconductor) allows the calculation only between two arrays of data. For this reason, we developed two novel scripts that make possible to perform dCor NxN phylogenetic profile comparison, where N is the number of genes in a given genome. In principle, the method is applicable also to binary phylogenetic profiles.

First, the matrix of the Euclidean distances was obtained calculating the difference between thek-th element and thel-th element of the phylogenetic profile as

$$ D=\left\lfloor {d}_{kl}\right\rfloor $$

where.

d kl  = |a k  − a l | r as the distance between the r-th pairs of elements of the profiles.

Second, each distance d kl of the matrix D was then converted into an element da kl of the matrix of the centered distances DA, calculated as

$$ {da}_{kl}={d}_{kl}-{\overline{d}}_k-{\overline{d}}_l+{\overline{d}}_{kl} $$

where.

\( {\overline{d}}_k=\frac{1}{n}\sum_{k=1}^n{d}_{kl} \) is the average calculated on the rows of the distance matrix;

\( {\overline{d}}_l=\frac{1}{n}\sum_{l=1}^n{d}_{kl} \)is the average calculated on the columns of the distance matrix;

\( {\overline{d}}_{kl}=\frac{1}{n^2}\sum_{k,l=1}^n{d}_{kl} \)is the average calculated on all the elements of the distance matrix;

where k = l = 1,.…, n = 1 ,…, j.

The distance correlation between the profilesA p andA q was calculated as

$$ {dCor}_{pq}=\frac{Cov\left({DA}_p,{DA}_q\right)}{\sqrt{Var\left({DA}_p\right) Var\left({DA}_q\right)}} $$

where Cov and Varrepresent the covariance and the variance of the matrices of the centered distances and p = q = 1 ,  …  , i.

Pearson’s correlation was calculated according to

$$ PC=\frac{\sum_{i=1}^n\left({x}_i-\overline{x\ }\right)\ \left({y}_i-\overline{y\ }\right)}{\sqrt{\sum_{i=1}^n\Big({x}_{i\kern0.5em }}-\overline{x}\left)2\sqrt{\sum_{i=1}^n{y}_i-\overline{y}}\right)2} $$

Where n is the size of the two arrays x and y, and \( \overline{x} \) and \( \overline{y} \) are the corresponding means.

Gold standards and predictive performance assessment

On the basis of KEGG database [17], we considered proteins belonging to the same metabolic pathway as functional related and hence to be included in the True Positive data set (TP-fun). To derive the True Negative data set (TN-fun), we developed a graph-based algorithm to identify non-interacting proteins. Proteins are included in TN-fun if the length of the shortest path between the metabolic pathways (sub-graphs) they belong was higher or equal to five.

The physically interacting proteins were derived from the STRING database [18]. Protein pairs with evidence about a direct physical interaction were considered as True Positive (TP-phy). True Negative data set (TN-phy) was obtained by applying the graph-based algorithm previously described.

The Area Under the Curve (AUC) was adopted as a measure of the prediction accuracy. The AUC was calculated as the sum of the approximated areas of the trapezoids obtained for each profile similarity score interval, according to the Gini’s formula

$$ AUC=\frac{1}{2}\sum_i\left(\left({X}_i-{X}_{i-1}\right)\left({Y}_i+{Y}_{i+1}\right)\right) $$

where X i is the false positive rate and Y i is the true positive rate at the i-th interval of profile similarity score. Each interval was set equal to 0.1 of distance correlation or of mutual information and the related rates were calculated. In order to perform the 10-fold cross-validations, each dataset was randomly divided in 10 subsets of equal size and the related AUCs calculated.

The total number of TPs and TNs obtained by dCor, PC and MI calculation in complete data set GS_fun and GS_phy in each reference set is provided in Additional file 1: Table S3.

Results and discussion

Reference set construction

It has been shown that the predictive performance of phylogenetic profiling is affected by the size and the genome composition of the reference set [19, 20]. To address this issue, we set up a procedure to construct a reference set that includes a number of genomes sufficiently high to ensure a robust statistics but excludes very similar organisms to avoid redundancy, spanning as much organisms diversity as possible.

To construct genome reference sets, we exploited information in the eggNOG database [17], where 1133 manually selected genomes were collected and classified as “core” (high quality genomes) and “peripheral” (genomes not completely validated) on the basis of genome coverage, status of gene annotation and gene completeness.

The first reference set (RS1) excluded all the strains of the same species classified as “peripheral” genomes. A second reference set (RS2) was generated from RS1 excluding the eukaryotic genomes with a “peripheral” attribute till having 45 eukaryotic genomes in a such way to pass from a ratio 5:1 to a ratio 13:1. To construct the third reference set (RS3), we progressively excluded “peripheral” prokaryotic genomes, in order to obtain the same ratio of RS1 but almost the half size. The last reference set (RS4) was obtained from RS3 on the basis of the Tree of Life derived from the eggNOG database, excluding close phylogenetically related eukaryotic genomes until reaching the same ratio of RS2 (Table 1). In all the four reference set 61 genome from Archea are included. The complete lists of genomes in RS1-RS4 are as Supplemental data (Additional file 2: Table S1).

Table 1 Summary of genomes in the reference sets

In this way, we obtained four reference sets of “high quality” genomes different in size and composition. Using each of the four reference sets, we constructed four phylogenetic profile data sets for S. cerevisiae and E. coli model genomes and evaluated the effect of the reference set size comparing RS1 vs RS3 and RS2 vs RS4, and composition, comparing RS1 vs RS2 and RS3 vs RS4.

Phylogenetic profiling

We applied the Smith-Watermann alignment algorithm [15] to align the S. cerevisiae and E. coli protein sequences against the reference sets. Phylogenetic profiles are constructed as arrays of probability values obtained by the E-values according to

$$ \boldsymbol{P}=-1/{\boldsymbol{log}}_{10}\left(\boldsymbol{E}\right) $$

For E-values higher than 10−1, the probability value is set to 1, as proposed in [5]. Phylogenetic profile matrices are available in Supplemental data (Additional file 3: Table S2).

Comparative analysis of phylogenetic profiling was performed using the dCor [13], the PC and the MI. In order to apply dCor calculation to biological large data sets, we developed a novel algorithm, Phylo_dCor (the strategy is schematically represented in Fig. 1). This proposed implementation strongly reduces the complexity of the original algorithm proposed by Szekelyet al. [13] and hence RAM requirements making it possible to install and run Phylo_dCor on a wide range of machines.

Fig. 1
figure 1

Pipeline of the dCor calculation. The phylogenetic profile matrix of Pi proteins constructed using a reference set of size Gj genomes (step a); starting from this data, the Di Euclidean jxj distance matrices (step b) and the DAi centered Euclidean distances (step c) were calculated applying a “split-apply-combine” algorithm; DAi matrices were stored in a repository of binary files (step d), from which they were extracted to proceed with the calculation of the distance correlation matrix (step e)

A first script (Phylo_dCor_step1.r) for the R environment was developed to calculate the matrix of centered distances from each phylogenetic profile. First, a phylogenetic profile matrix Pi x Gj was constructed where Pi are the probability values calculated for each hit found in the Gj genomes of the reference set (step a). Then, we adopted a “split-apply-combine” strategy using the plyr R package [21]. This allowed us to parallelize the most “time-consuming” steps subdividing the Pi xGj matrix into N sub-matrices and hence the calculations of the Euclidean distance matrices (step b) and of the Euclidean centered distance matrices (step c). The resulting matrices of centered distances were stored in a repository of binary files (.rds) (step d). A second R code (Phylo_dCor_step2.r) was developed to perform the calculation of the distance correlation (step e).

To evaluate the performance of the method, a ten-fold cross-validation procedure was carried out on two different sets of gold-standards. The first set was derived from the metabolic pathways in KEGG database [22], and includes as TPs pairs of functionally related proteins (GS_fun), the second set was obtained from the STRING database [18], to assess the performance in predicting physical protein-protein interactions (GS_phy). The predictive performance was estimated by calculating the Area Under the ROC Curve (AUC) values for each of the 10 randomly selected independent subsets.

The analysis was performed on all proteins deduced from the two model genomes, including paralogs and possible horizontal gene transfers. Being them considered in all the three assessments, the comparative predictive performance of dCor, PC and MI was not affected. Moreover, possible false positives can be evaluated and eventually filtered away in a second step.

In Fig. 2 results regarding the assessment on GS_fun are shown in panels a and b, while results obtained using GS_phy are reported in panel a’ and b’. In all cases but one, the predictive performance of the phylogenetic profiling using dCor (grey box-plot) outperforms the one obtained using MI (empty box-plot) and PC (ligth blue box-plot). We confirmed that both size and composition of the reference set affect phylogenetic profiling. However, the use of dCor and PC to compare phylogenetic profiles strongly reduces this effect, especially in the case of the eukaryotic genomes. In general, it seems that physical interactions (Fig. 2, panels a’ and b’) are predicted better than functional relationships. This could be due to a higher robustness of the gold standards GS-phy than GS-fun, in that physical interactions are experimentally validated. PC outperforms dCor in the case of the GS-Fun gold standard in E. coli, furthermore in this case the effect of the size and/or genome composition of the reference sets affects also the predictive performance of correlation measures.

Fig. 2
figure 2

Benchmarking of Phylo-dCor application. Results of the ten-fold cross-validation procedure to assess predictive performances of dCor (grey box plots), PC (ligth blue box plots) and MI (empty box plots). Results obtained using GS_fun benchmark are shown in panels a and b, while in panels a’ and b’ are reported results obtained using GS_phy

Collectively, our results indicate that the proposed application is robust, and significantly improves the performance of PPI prediction. It can efficiently handle large genomic data sets and does not require high calculation capacity.

Conclusions

The increasing number of fully sequenced genomes led to a renewed interest in the elaboration of powerful methods to predict both functional and physical protein-protein interactions. In this framework, we propose a novel phylogenetic profiling procedure using distance correlation as a similarity measure of phylogenetic profiles. To make it applicable to large genomic data, we developed Phylo-dCor, a parallelized version of the original algorithm for calculating the distance correlation. Two R scripts that can be run on a wide range of machines will be made available on request. Furthermore, we adopted a new strategy of genome selection to obtain unbiased and large reference sets of genomes. In two model genomes: E. coli and S. cerevisiae we showed that the distance correlation outperforms phylogenetic profiling methods previously described.

Abbreviations

dCor:

distance correlation

MI:

Mutual Information

PC:

Pearson’s correlation

RS:

Reference Set

TN:

True Negative

TP:

True Positive

References

  1. Enright AJ, Iliopoulos I, Kyrpides NC, Ouzounis CA. Protein interaction maps for complete genomes based on gene fusion events. Nature. 1999;402:86–90. doi:10.1038/47056.

    Article  CAS  PubMed  Google Scholar 

  2. Marcotte EM, Pellegrini M, Ng HL, Rice DW, Yeates TO, Eisenberg D. Detecting protein function and protein-protein interactions from genome sequences. Science. 1999;285:751–3. 10427000

    Article  CAS  PubMed  Google Scholar 

  3. Overbeek R, Fonstein M, D’Souza M, Pusch GD, Maltsev N. The use of gene clusters to infer functional coupling. Proc Natl Acad Sci U S A. 1999;96:2896–901. 10077608

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  4. Pellegrini M, Marcotte EM, Thompson MJ, Eisenberg D, Yeates TO. Assigning protein functions by comparative genome analysis: protein phylogenetic profiles. Proc Natl Acad Sci U S A. 1999;96:4285–8. 10200254

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  5. Date SV, Marcotte EM. Discovery of uncharacterized cellular systems by genome-wide analysis of functional linkages. Nat Biotechnol. 2003;21:1055–62. doi:10.1038/nbt861.

    Article  CAS  PubMed  Google Scholar 

  6. Dey G, Meyer T. Phylogenetic profiling for probing the modular architecture of the human genome. Cell Syst. 2015;1:106–15. doi:10.1016/j.cels.2015.08.006.

    Article  CAS  PubMed  Google Scholar 

  7. McDermott J, Bumgarner R, Samudrala R. Functional annotation from predicted protein interaction networks. Bioinformatics. 2005;21:3217–26. doi:10.1093/bioinformatics/bti514.

    Article  CAS  PubMed  Google Scholar 

  8. Lv Q, Ma W, Liu H, Li J, Wang H, Lu F, Zhao C, Shi T. Genome-wide protein-protein interactions and protein function exploration in cyanobacteria. Sci Rep. 2015;5:15519. doi:10.1038/srep15519.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  9. Li Y, Calvo SE, Gutman R, Liu JS, Mootha VK. Expansion of biological pathways based on evolutionary inference. Cell. 2014;1:213–25. doi: 10.10167j.cell.2014.05.034

    Article  Google Scholar 

  10. Pellegrini M. Using phylogenetic profiles to predict functional relationships. Methods Mol Biol. 2012;804:167–77. doi:10.1007/978-1-61779-361-5_9.

    Article  CAS  PubMed  Google Scholar 

  11. Kensche PR, van Noort V, Dutilh BE, Huynen MA. Practical and theoretical advances in predicting the function of a protein by its phylogenetic distribution. J R Soc Interface. 2008;5:151–70. doi:10.1098/rsif.2007.1047.

    Article  CAS  PubMed  Google Scholar 

  12. Simon N, Tibshirani R. Comment on ‘detecting novel association in large data sets’ by Reshef et al.. Science, 2011. 2011 arXiv. 1401:7645.

  13. Szekely GJ, Rizzo ML, Bakirov NK. Measuring and testing dependence by correlation of distances. Ann Statist. 2007;35:2769–94. doi:10.1214/009053607000000505.

    Article  Google Scholar 

  14. Szekely GJ, Rizzo ML. Brownian distance covariance. Ann Statist. 2009;3:1236–65. doi:10.1214/09-AOAS312.

    Article  Google Scholar 

  15. Smith TF. Watermann MS 1981. Identification of common molecular subsequences. J Mol Biol. 1981;147:95–197. 7265238

    Article  Google Scholar 

  16. Ding B, Gentleman R, Carey V. bioDist: different distance measures. R package version 148. 2017:0.

  17. Powell S, Szklarczyk D, Trachana K, Roth A, Kuhn M, Muller J, Arnold R, Rattei T, Letunic I, Doerks T, Jensen LJ, von Mering C, Bork P. eggNog v3.0: Orthologous groups covering 1133 organisms at 41 different taxonomic ranges. Nucleic Acids Res. 2012;40:D284–9. doi:10.1093/nar/qkr1060.

    Article  CAS  PubMed  Google Scholar 

  18. Franceschini A, Szklarczyk D, Frankild S, Kuhn M, Simonovic M, Roth A, Lin J, Minquez P, Bork P, von Mering C, Jensen LJ. 2013. STRING v9.1: Protein-protein interaction networks, with increased coverage and integration. Nucleic Acids Res. 2013;41:808–15. doi:10.1093/nar/qks1094.

    Article  Google Scholar 

  19. Snitkin ES, Gustafson AM, Mellor J, Wu J, DeLisi C. Comparative assessment of performance and genome dependence among phylogenetic profiling methods. BMC Bioinformatics. 2006;7:420–31. doi:10.1186/1471-2105-7-420.

    Article  PubMed  PubMed Central  Google Scholar 

  20. Sun Li Y, Zhao Z. Phylogenetic profiles for the prediction of protein-protein interactions: how to select reference organisms? Biochem Biophys Res Commun. 2007;353:985–91. doi:10.1016/j.bbrc.2006.12.146.

    Article  Google Scholar 

  21. Wickham H. The split-apply-combine strategy for data analysis. J Stat Softw. 2011;40:1–29. doi:10.18637/jss.v040.i01.

    Google Scholar 

  22. Kanehisa M, Goto SKEGG. Kyoto encyclopedia of genes and genomes. Nucleic Acids Res. 2000;28:27–30. 10592173

    Article  CAS  PubMed  PubMed Central  Google Scholar 

Download references

Acknowledgements

We are grateful to Barbara Caccia and Stefano Valentini for useful discussions and technical support.

Funding

This work was supported by the European Community’s Seventh Framework Programme (FP7/2007–2013) under Grant Agreement No. 242095 and by the Italian FLAGSHIP “InterOmics” project (PB.P05).

Availability and requirements

The data utilized to construct the reference sets are available at EggNOG database v3.0 (http://eggnogdb.embl.de/#/app/home); gold standards were constructed using data from the KEGG pathway (http://www.genome.jp/kegg/) and the STRING (https://string-db.org/) databases.

Two two R scripts (Phylo_dCor_step1.r and Phylo_dCor_step2.r) can be run on a wide range of machines and will be made available on request.

Author’s Contributions

GS and EP conceived of the study, GS and FF developed the software application, GS, EP and MP discussed results and wrote the paper. All authors read and approved the final version of the manuscript.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Elisabetta Pizzi.

Ethics declarations

Ethics approval and consent to participate

Not applicable.

Consent for publication

Not applicable.

Competing interest

The authors declare that they have no competing interests.

Publisher’s Note

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

Additional files

Additional file 1: Table S3.

Table of TPs and TNs. The number of True Positives and True Negatives obtained by dCor, MI and PC calculation for each reference set and each gold standard (GS-fun and GS-phy) for E. coli and S.cerevisiae. (XLSX 23 kb)

Additional file 2: Table S1.

List of reference set genomes. The complete lists of genomes utilized for construction of reference sets RS1-RS4. (XLSX 85 kb)

Additional file 3: Table S2.

Phylogenetic profile matrices. The phylogenetic profiles derived for E. coli and S. cerevisiae using the reference set RS1. (XLSX 68277 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

Sferra, G., Fratini, F., Ponzi, M. et al. Phylo_dCor: distance correlation as a novel metric for phylogenetic profiling. BMC Bioinformatics 18, 396 (2017). https://doi.org/10.1186/s12859-017-1815-5

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s12859-017-1815-5

Keywords