Abstract
Among proteins, orthologs are defined as those that are derived by vertical descent from a single progenitor in the last common ancestor of their host organisms. Our goal is to compute a complete set of protein orthologs derived from all currently available complete bacterial and archaeal genomes. Traditional approaches typically rely on all-against-all BLAST searching which is prohibitively expensive in terms of hardware requirements or computational time (requiring an estimated 18 months or more on a typical server). Here, we present xBASE-Orth, a system for ongoing ortholog annotation, which applies a “divide and conquer” approach and adopts a pragmatic scheme that trades accuracy for speed. Starting at species level, xBASE-Orth carefully constructs and uses pan-genomes as proxies for the full collections of coding sequences at each level as it progressively climbs the taxonomic tree using the previously computed data. This leads to a significant decrease in the number of alignments that need to be performed, which translates into faster computation, making ortholog computation possible on a global scale. Using xBASE-Orth, we analyzed an NCBI collection of 1,288 bacterial and 94 archaeal complete genomes with more than 4 million coding sequences in 5 weeks and predicted more than 700 million ortholog pairs, clustered in 175,531 orthologous groups. We have also identified sets of highly conserved bacterial and archaeal orthologs and in so doing have highlighted anomalies in genome annotation and in the proposed composition of the minimal bacterial genome. In summary, our approach allows for scalable and efficient computation of the bacterial and archaeal ortholog annotations. In addition, due to its hierarchical nature, it is suitable for incorporating novel complete genomes and alternative genome annotations. The computed ortholog data and a continuously evolving set of applications based on it are integrated in the xBASE database, available at http://www.xbase.ac.uk/.
Introduction
A central goal in comparative genomics is to identify novel and/or shared biology between organisms, or at least make informed predictions in this regard. The discovery of sets of orthologous proteins plays an important role towards elucidating such relationships. Fitch [1] originally proposed the definition of orthologs as homologous proteins related via speciation. Under this definition of orthologs “it is both theoretically plausible and empirically supported that due to their sequence similarity they have similar structure and typically perform equivalent biological function” [2]. Paralogs, on the other hand, are created via gene duplication and are prone to diversification, which can lead to them acquiring biologically distinct functions. As lines of descent are rarely known, a practical approach for inferring orthology is to compare protein sequences and draw conclusions based on sequence similarity. The existence of co-orthologs, i.e. where a pair of paralogs from one genome is orthologous to a protein or a pair of paralogs from another, can complicate such approaches and requires further consideration.
Assignments of orthology are required in numerous contexts, including determining gene content and creating annotation for newly sequenced genomes; taxonomic and phylogenetic studies; estimation of the number of novel genes expected when sequencing a new strain from a known species [3]; and identifying novel drug targets [4].
Existing techniques for ortholog computation fall in two major categories – tree-based and pair-based. Tree-based techniques (e.g., [5]–[10]) identify all similar genes among a set of genomes, build a phylogenetic tree for each family of homologs and use the trees to distinguish between orthologs and paralogs (orthology inferred if tree for protein identical to that for whole genomes). Pair-based techniques (e.g., [11]–[25]) use a heuristic approach to identify pairs of similar genes belonging to different genomes and then organize them into orthologous groups by performing a subsequent clustering step to filter out some co-orthologous pairs.
Tree-based techniques are generally thought to perform better than pair-based approaches [26], but in many cases it appears that the two approaches perform equally well [27], [28]. Even if considered the “gold standard”, tree-based approaches are not feasible for large projects, involving millions of proteins, as they are slow and resource-hungry in computational terms and difficult to automate. OrthoMCL is a popular representative of the pair-based approach to ortholog computation, providing an attractive trade-off between sensitivity and specificity [27], [28] and ability to handle evolutionary distant sequences. In addition, OrthoMCL analyses are not limited to pair-wise comparisons and can be automated.
We wished to compute orthologs for the large and ever-increasing set of complete prokaryotic genomes. However, an off-the-shelf adoption of OrthoMCL for analyzing the current 1,382 complete prokaryotic genomes from the NCBI collection would make unrealistic demands on time or computational capacity. Based on the OrthoMCL algorithmic complexity – a quadratic function of the number of coding sequences (CDSs) alignments to be performed, we estimate that it would take more than 18 months to analyze the current 1,382 genomes on a typical server, i.e. four 2.3 GHz CPUs and 16 GB RAM (see Results). In other words, if we were to start the ortholog computation using directly OrthoMCL today, by the time the computation was finished, we would be faced with a four-fold bigger problem, given the NCBI's 18-month doubling rate for prokaryotic genomes and the solution's quadratic complexity. One might argue that such a problem could still be solved in reasonable time given extensive use of computational resources (e.g. in the cloud). However, even this solution is not sustainable, as three years from today the problem will be 16 times larger and, in only nine years, it will have increased over 4,000-fold!
Faced with these challenges, we devised an alternative approach, xBASE-Orth, to provide a scalable and efficient system for ortholog annotation. xBASE-Orth is a pair-based technique, which relies on bidirectional best-hit calculations, applies a “divide and conquer” approach and adopts a pragmatic scheme that trades accuracy for speed. Starting at species level, xBASE-Orth carefully constructs and uses pan-genomes as proxies for the full collections of coding sequences at each level as it progressively climbs the taxonomic tree using the previously computed data (see Methods). This leads to a significant decrease in the number of alignments that need to be performed, which translates into faster computation, making ortholog computation possible on a global scale.
Results
Predicted Ortholog Pairs and Groups
Using xBASE-Orth, we analyzed 94 archaeal and 1,288 bacterial complete genomes available in the NCBI's RefSeq collection (February 2011, see Dataset S1) containing 4,431,241 CDSs. As can be seen from Figure 1, we found a total of 719,477,188 ortholog pairs analyzing all possible genome pairs in the bacterial and archaeal domains. xBASE-Orth could not find any ortholog for 7.5% of the CDSs; for the remaining 92.5% of the CDSs there are ∼350 orthologs per CDS on average.
Using the ortholog pairs data, we organized the CDSs in ortholog groups (OGs) using the single-linkage approach (i.e., a CDS is clustered to an ortholog group if it forms an orthologous pair with at least one CDS from this group). Each of the generated 15,874 (Archaea) and 159,657 (Bacteria) ortholog groups contains 2 or more CDSs and each CDS belongs to one group only. Based on the OGs, we computed the frequency of occurrence of the CDSs in the considered genomes (Figure 2). Our results are in accordance with the estimations made in [29]: a significant fraction of all CDSs (about one-third for Archaea and one-half for Bacteria in our computation) are present only in a small percentage of genomes (less than or equal to 10%) – i.e. the “accessory pool”; about 10% of all CDSs have orthologs in more than 90% of the genomes – i.e. the “extended core”.
The computed orthologs are integrated in the xBASE database (http://xbase.ac.uk/). The ortholog pairs/ortholog group for a CDS can be fetched via the xBASE web-interface by entering the CDS locus tag in the search box, following the “Genome View” link, and selecting the desired option from the left-hand panel.
Timing and Speedup
We implemented the xBASE-Orth pipeline in Python and conducted the experiments using a 4×2.3 GHz CPUs, 16 GB RAM Blade server. Analyzing the 1,382 complete prokaryotic genomes took a total of 889 hours (∼37 days), the vast majority of which (>80%) was spent performing alignments of amino acid sequences. Figure 3 shows a more detailed report on the computation times for xBASE-Orth at each level, as well as the estimated speedup achieved by xBASE-Orth compared to a brute-force use of OrthoMCL. The estimation of the OrthoMCL computation times is based on the fact that both xBASE-Orth and OrthoMCL computation times are quadratic functions with respect to the number of CDSs to be aligned. Since xBASE-Orth uses pan-genomes rather than the full CDS collections (see Methods), it performs an order of magnitude fewer alignments (Columns 3 and 4), resulting in estimated overall speedup of about 15-fold.
Comparison with OrthoMCL
To evaluate the accuracy of xBASE-Orth, we compared its predicted ortholog pairs (OP) to the OP produced by OrthoMCL (given the full set of CDSs) for three evolutionary distant phyla – Bacteroidetes (40 complete genomes), Cyanobacteria (41 genomes) and Euryarchaeota (62 genomes). Using pan-genomes as proxies to the full CDS collections provides a significant computation speedup for xBASE-Orth, but introduces some differences in the predicted orthologs (Figure 4). The difference in the predicted ortholog pairs between the two techniques increases with the evolutionary distance. At higher taxonomic levels the pan-genomes are more compressed, i.e. each CDS in a pan-genome is a representative of a larger set of orthologous/paralogous CDSs, thus becoming less sensitive and specific.
xBase-Orth Sensitivity and Specificity
To determine the quality of the xBASE-Orth ortholog prediction, we investigated its sensitivity and specificity. In our context, sensitivity refers to the ability to discover distant orthologs. As shown in Figure 1, xBASE-Orth could not find orthologs for 7.5% of the CDSs, ∼80% of which are annotated as “hypothetical proteins”. This number is in accordance with the results reported previously for detecting singleton ORFans (i.e. CDSs with no homology with any other protein from a genome collection) - 14.4% analyzing 127 microbial genomes [30], 14% in 60 genomes [31], 12% in 122 genomes [32], 7.8% in 277 genomes [33] and typically 10–15% [34]. For the remaining 92.5% of the CDSs, the average distribution of orthologs found across the taxonomic levels is: 2% at species and genus level each, 4% at family and order level each, 12% at class level, 21% at phylum level and 55% at domain level, which indicates suitable sensitivity of xBASE-Orth.
To investigate the specificity of xBASE-Orth, i.e. avoiding spurious ortholog pairs, we performed the following analysis. For a given CDS, we fetched all of its predicted orthologs, performed a multiple alignment of the CDSs in this orthologous group with ClustalW2 [35] using default parameters and subsequently scored the alignment with the norMD tool [36]. Since it would be impractical to perform this analysis for each of the 4.1 million CDSs for which an ortholog is found, we selected a representative subset of CDSs, such that: i) each chosen CDS has at least one ortholog from each taxonomic level; ii) it has no more than 150 orthologs in total, in order to keep multiple alignment computation times reasonable; and iii) all orthologous groups are disjoint (each CDS from any group belongs to this group only), in order to avoid sampling bias. There are 2,384 such CDSs with a total of 190,187 orthologs distributed across the taxonomic levels as follows: 3.3% at species level, 8.6% at genus, 3.9% at family, 11.3% at order, 12.5% at class, 30.7% at phylum, and 29.8% at domain level.
As shown in Figure 5, for 84% of the orthologs groups the computed norMD value is at least 0.5 (mean norMD = 0.63, σ = 0.16), which is considered to be the cutoff value for distinguishing between good and poor multiple alignment quality [36]; in only 16% of the cases the set of discovered orthologs contains some spurious (or very divergent) orthologs. This result indicates that xBASE-Orth provides suitable specificity even at large evolutionary distances (∼60% of the orthologs for the 2,384 CDSs are at phylum and domain level). For comparison, the tree-based Build_Fam algorithm for constructing the HOGENOM database is shown to outperform OrthoMCL in most of the cases for analyzing 219,951 proteins from 50 bacterial, archaeal and eukaryotic genomes and achieves mean norMD = 0.59, where 74% of the groups have norMD ≥0.5 [10].
The Bacterial Core Genome
The core genome for a taxonomic group is the collection of CDSs that are present in all of the genomes in this group. However, given the variability of approaches and uncertain accuracy of CDS prediction and annotation across all available bacterial genomes, we adopted a less stringent definition, namely that a CDS had to be present in 90% of the set of bacterial genomes to be termed a highly conserved bacterial ortholog (HCBO). Based on the data in the ortholog groups, we have computed a list of the HCBOs for the domain Bacteria by analyzing all 1,288 bacterial genomes (a significant increase on previous efforts which exploited far fewer genomes).
We identified 195 CDSs as HCBOs in the domain Bacteria (Figure 6, Figure 7 and Dataset S2). The number of HCBOs in the domain Bacteria predicted by xBASE-Orth is in accordance with the estimated ∼250 bacterial extended core CDSs based on the analysis of 573 genomes [29]. Ciccarelli and colleagues [37] analyzed 150 bacterial, 18 archaeal and 23 eukaryotic genomes and determined a set of 36 core CDSs. Our list of HCBOs contains 35 of their 36 core CDSs, but lacks leucyl-tRNA synthetase.
We also computed the archaeal core genome and compared our result with reported data. Previous work predicted archaeal core genome size ranging from 543 CDSs by analyzing 4 genomes [38], 480 by 6 genomes [39], 166 by 41 genomes [40], to 152 CDSs by analyzing and manual curation of the results for almost all of the considered 70 genomes in the unpublished “2009 arCOG update” of [40], available at ftp://ftp.ncbi.nih.gov/pub/wolf/COGs/arCOG/. Our computations produced a list of 261 highly conserved archaeal orthologs (HCAOs) occurring in at least 90% of the 94 genomes (Dataset S3). Overall, our results confirm the findings in the “2009 arCOG update” – 138 of the CDSs were found by both approaches. Only 14 arCOGs were not discovered by xBASE-Orth, possibly due to miscalled CDSs and/or the 24 additional archaeal genomes considered in our analysis. On the other hand, as a result of the more relaxed 90% threshold, xBASE-Orth suggests an additional 123 CDSs that rank as highly conserved archaeal orthologs.
Comparing the COG functional category distributions of the bacterial and archaeal core genomes, it is interesting to note that while the two have similar proportion of core CDSs related to information storage and processing (55.6% in Bacteria vs. 54.5% in Archaea), the archaeal core genome contains more metabolism related CDSs (26.3% vs. 19.0%) and significantly less core CDSs related to cellular processes (7.9% vs. 21.5%).
Genome Plasticity
The term ‘species pan-genome’ was coined by Tettelin and colleagues [41] and “includes a core genome containing genes present in all strains and a dispensable genome composed of genes absent from one or more strains and genes that are unique to each strain”. Closed pan-genomes indicate species with static genomic content – for such species it is possible to acquire their full CDS repertoire by sequencing enough genomes. In contrast, open pan-genome indicates species with dynamic genomic content, which translates into “infinite” species CDS repertoire - regardless of the number of already analyzed genomes, each newly sequenced strain can be expected to reveal some CDSs unique within species.
We investigated the open/closed pan-genome property for 34 species with 5 or more complete genomes using the technique proposed in [42], defining new CDSs as CDSs with no orthologs (cut-off 70% identity over 70% of the length of the shorter peptide) and no paralogs (90%, 90% cut-offs) and using medians over 100 random genome order permutations. As shown in Figure 8, about one third of considered species have closed pan-genomes (α>1, Figure 9), while the rest have dynamic genomic content (α≤1, Figure 10). We compared our results with previously published predictions available for 15 species [3], [42]–[51] and our predictions generally agree with published data with four exceptions shown in gray in Figure 8. The differences are due to different cut-offs (S. aureus), different methodologies in computing the content of the pan-genome (P. marinus) and different strains being considered (H. influenzae, C. jejuni). Particularly interesting is the case of H. influenzae. Analyzing only strains isolated in North America, its pan-genome is predicted to be large, but closed [46]. Our analysis is based on 6 of these strains, as well as including the H. influenzae 10810 strain isolated in the UK (deposited to NCBI Nov, 2010, accession number FQ312006), which is somehow distinct from the remaining strains – it contains 1,914 CDSs, more than any of the other 6 strains (average of ∼1,700 CDSs) and has more species-unique CDSs (198) than any of the other 6 strains (average of ∼60 CDSs), leading to a borderline open pan-genome prediction. This result illustrates the possible caveat of drawing general conclusions based on closely related isolates (which Hogg and colleagues also pointed out).
We also evaluated the 34 species by computing their genomic fluidity [52]. Results are reported in Figure 8, where a genomic fluidity of 0.2 implies that 20% of the CDSs in a genome pair are unique to their host genome, while 80% are shared. The difference between the two approaches is best illustrated considering A. pasteurianus – the analysis of the pan-genome suggests a widely open pan-genome; while according to the genomic fluidity approach A. pasteurianus has one of the highest genome similarity, due to the very small proportion of the unique CDSs found for each genome pair.
Discussion
We have devised an approach that allows for scalable and efficient computation of the bacterial and archaeal ortholog annotations. In addition, due to its hierarchical nature, it is suitable for incorporating novel complete genomes and alternative genome annotations. The proposed xBASE-Orth exploits the available taxonomic information by adopting a “divide and conquer” approach that pragmatically trades accuracy for speed and as a result circumvents the usual high computational cost of ortholog prediction. However, there are several factors that affect the quality of the xBASE-Orth computations – the problem of horizontal gene transfer, quality of the CDS prediction, the approximate nature of our solution, and the sequence similarity paradigm on which it is based, as discussed next.
Our ortholog computation does not take into consideration horizontal gene transfer, which means that for mobile genetic elements such as bacteriophages our approach will predict CDSs to be orthologous when they do not fit the classical Fitch definition of orthologs, i.e. homologous proteins related via speciation [1]. However, this is part of the trade-off between speed and accuracy, as creation and evaluation of phylogenetic trees for each CDS family would be too computationally costly to be feasible. Nonetheless, in almost all cases, xBASE-Orth will provide sound inferences of homology and thereby of function.
Our ortholog computation approach depends on the NCBI's CDS annotation and is therefore affected by the quality of the CDS prediction. The proportion of bacterial genomes (953/1288) in which at least one HCBO was missing based on the CDS annotation is surprisingly high (Dataset S2). For example, among the Escherichia coli species, the genome with the highest number of apparently missing HCBOs (ten) is E. coli APEC O1. However, performing a search in the E. coli APEC O1 genome sequence finds highly plausible hits for all ten HCBOs. To address this problem, we performed a direct six-frame sequence search in all genome sequences which miss at least one HCBO/HCAO using PROMER [53] and a representative subset of the HCBO/HCAO in question as a query set. In about 25% of the cases in which a HCBO cannot be found in the annotated CDSs from a genome, a plausible hit was found through PROMER. The implied defects in annotation underline the need for an optimal and consistent community-wide approach to CDS prediction. Interestingly, performing PROMER searches for apparently missing HCAOs suggest CDS prediction is better in archaeal genomes than in bacteria – plausible hits were found in less than 15% of the cases. These PROMER results have been incorporated into our final assessments of HCBOs and HCAOs presented in Figures 6 and 7 and Datasets S2 and S3.
A comparison between our set of HCBOs (Figure 6) and the expected bacterial core genome, based on what one would predict to be necessary for core informational processes of transcription and translation, reveals some unexpected absences. In some cases, these result from the trade-off between sensitivity and speed. For example, the ribosomal protein S16 is missing from our HCBOs, as xBASE-Orth separates this family of proteins into two clusters – one exclusive to Firmicutes, the other from all other bacteria (present in 76.3% of genomes). Performing a six-frame PROMER alignment reveals only less than 2% of all cross-cluster CDSs pairs have detectable similarity. Being an approximate solution (using pan-genomes rather than the full CDS collection), xBASE-Orth fails to find this similarity, due to selecting a quite distinct CDS as a representative of the S16s in Firmicutes.
Ribosomal protein S21 is also absent from our HCBOs. The S21 proteins are separated into several ortholog groups – the largest cluster, present in 71.5% of genomes, contains CDSs from all phyla except Deferribacteres; two clusters for Cyanobacteria; three clusters for Tenericutes; four clusters for Chloroflexi and eight clusters for Proteobacteria. All S21 proteins in Deferribacteres are grouped together and form the second largest cluster including S21s from some Alphaproteobacteria and Deltaproteobacteria genomes. An attempt to reconcile the two largest clusters using six-frame PROMER alignment reveals no detectable similarity between any pair of CDSs from these two clusters. Incorporation of more sensitive approaches to homology searching might solve this problem, but only at the expense of time and resources.
Another surprise stems from the fact that some CDSs, which are correctly predicted as HCBOs, could not be found in certain genomes, even with six-frame PROMER search. Examples include ribosomal protein L2 (occurrence rate 99.9%) not found in Streptococcus mutans UA159, ribosomal protein L6 (occurrence rate 99.8%) not found in Granulibacter bethesdensis CGDNIH1, ribosomal protein L11 (occurrence rate 99.8%) not found in Thermoanaerobacter mathranii subsp. mathranii str. A3 (although ribosomal L11 methyltransferase is found and annotated in the genome). Potential explanations for these anomalies include errors in the processes of sequencing and assembly, extreme sequence divergence, or a genuine absence of the HCBOs in these genomes.
In conclusion, with xBASE-Orth we have circumvented the usual high computational cost of ortholog prediction by adopting a “divide and conquer” approach that pragmatically trades accuracy for speed. We are confident that this approach will provide scalability for some years to come and that our ortholog dataset and predictions of HCBOs and HCAOs will provide a tool for experimentalists to generate laboratory-testable hypotheses.
Methods
Computing Paralogs
The computation of the paralogous CDS pairs in each genome is done using the PROMER tool [53] to perform six-frame alignments in amino-acid space of all-vs-all CDSs in a genome, with no explicit identity and coverage thresholds imposed. For each discovered paralogous pair, only the highest scoring alignment is recorded in our database.
Computing Species Orthologs
A recent study [28] concluded that for relatively close genomes, the BBH (bidirectional best-hit, also referred to as reciprocal best-hit, RBH) approach provides an acceptable trade-off between accuracy and computational time. Our species ortholog computation expands the traditional BBH approach by being “synteny-aware”. For each possible genome pair within a species we perform six-frame whole-genome pair-wise alignments in amino-acid space using the PROMER tool, chosen over BLAST [54] for its computational efficiency and its suitability for closely related genomes. Next, the aligned regions are sorted based on their length. Starting from the longest alignment, orthologs are detected by a PROMER computation of the similarity between CDSs in the aligned regions and selecting the bidirectional best hits (identity ≥70%, coverage ≥70%). A BBH pair is predicted to be orthologous if none of the two CDSs in the pair is part of previously predicted ortholog pair. In this way, we are filtering out a subset of co-orthologs which do not belong to syntenic blocks. Computing the species orthologs as described took ∼10 days on our server and proceeding in the same accurate but computationally intensive manner would require more than 10 years. The vast majority of the time at this step was spent performing alignments and to reduce their number at higher taxonomic levels, we adopted the pan-genome based scheme that trades accuracy for speed.
Computing Species Pan-Genomes
Starting with the set of all CDSs from a species, we compute all homologous groups (paralogy cut-off: identity ≥90%, coverage ≥90%, orthology cut-off: identity ≥70%, coverage ≥70%) using the single-linkage approach (i.e., a CDS is clustered to a group if it forms a pair with at least one CDS from this group). In the pan-genome we record all CDSs for which no paralog or ortholog is found, as well as a single representative of each homologous group. We chose to use as a representative the CDS with the largest number of orthologs at this level. Note that our pan-genome computation does not depend on the order in which the genomes are considered (a difference with the traditional sequential inclusion pan-genome computation [41]) – starting with and using all CDSs results in more biologically representative and ∼2% smaller species pan-genomes. While this difference is smaller at species level, it grows more substantial at higher taxonomic levels.
Computing Genus and Higher Level Orthologs
The synteny-aware BBH approach we used for computing species orthologs is not suitable for ortholog prediction in more phylogenetically distant genomes [11]. We compute orthologs at genus and higher levels as follows. First, the pan-genomes of all species in a genus is computed, as described above. Next, the collection of the species pan-genomes is given as input to OrthoMCL, rather than the full genus CDS collection. OrthoMCL performs an all-versus-all protein BLAST of the CDSs, detects the BBH pairs above user-specified match and e-value thresholds and augments the 1∶1 BBH pairs with in-paralogs using bootstrapping and Markov matrices. We refer to the OrthoMCL result as the set of “explicit” ortholog pairs. At the last step in our algorithm, the set of explicit orthologs are expanded by mapping them to each inter-species pair of genomes using the already computed species ortholog and genome paralog data. For example, if CDS X from species A forms an explicit ortholog pair with CDS Y from species B, then each homolog of X in species A forms an “implicit” ortholog pair with each homolog of Y in species B and all such implicit pairs are added to the set of ortholog pairs. The orthologs at family, order, class, phylum, and domain levels are computed in similar manner, adjusting the OrthoMCL parameter values accordingly (min peptide length = 33 aa, max percentage of stop codons = 2%, e-value cut-off = 1×10−5, I = 1.5, percent match cut-off = 65% at genus level, 60% family, 55% order, 50% class, 45% phylum and 40% at domain level).
Computing Genus and Higher Level Pan-Genomes
Computing the pan-genomes at genus and higher levels is done in a manner similar to the one for species pan-genomes. Starting with the collection of pan-genomes of all species within a genus, replace each explicit orthologous group with a single representative CDS - the one with the largest number of genus orthologs (both explicit and implicit). Note that we do not consider the implicit genus orthologs data in pruning the genus pan-genome - although it will result in significantly smaller pan-genomes, it will negatively affect the accuracy of the computation for higher taxonomic levels.
Supporting Information
Footnotes
Competing Interests: The authors have declared that no competing interests exist.
Funding: This work is supported by the Biotechnology and Biological Sciences Research Council (http://www.bbsrc.ac.uk/), grant number BBE0111791. The funders had no role in study design, data collection and analysis, decision to publish, or preparation of the manuscript.
References
- 1.Fitch WM. Distinguishing homologous from analogous proteins. Syst Zool. 1970;19(2):99–113. [PubMed] [Google Scholar]
- 2.Koonin EV. Orthologs, paralogs, and evolutionary genomics. Annu Rev Genet. 2005;39:309–338. doi: 10.1146/annurev.genet.39.073003.114725. [DOI] [PubMed] [Google Scholar]
- 3.Medini D, Donati C, Tettelin H, Masignani V, Rappuoli R. The microbial pan-genome. Curr Opin Genet Dev. 2005;15(6):589–594. doi: 10.1016/j.gde.2005.09.006. [DOI] [PubMed] [Google Scholar]
- 4.Muzzi A, Masignani V, Rappuoli R. The pan-genome: towards a knowledge-based discovery of novel targets for vaccines and antibacterials. Drug Discov Today. 2007;12(11–12):429–439. doi: 10.1016/j.drudis.2007.04.008. [DOI] [PubMed] [Google Scholar]
- 5.Storm CEV, Sonnhammer ELL. Automated ortholog inference from phylogenetic trees and calculation of orthology reliability. Bioinformatics. 2002;18(1):92–99. doi: 10.1093/bioinformatics/18.1.92. [DOI] [PubMed] [Google Scholar]
- 6.Zmasek CM, Eddy SR. RIO: analyzing proteomes by automated phylogenomics using resampled inference of orthologs. BMC Bioinformatics. 2002;3:14. doi: 10.1186/1471-2105-3-14. doi: 10.1186/1471-2105-3-14. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 7.Wapinski I, Pfeffer A, Friedman N, Regev A. Automatic genome-wide reconstruction of phylogenetic gene trees. Bioinformatics. 2007;23(13):i549–i558. doi: 10.1093/bioinformatics/btm193. [DOI] [PubMed] [Google Scholar]
- 8.Hubbard TJ, Aken BL, Beal K, Ballester B, Caccamo M, et al. Ensembl 2007. Nucleic Acids Res. 2007;35(Database issue):D610–D617. doi: 10.1093/nar/gkl996. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 9.Vilella AJ, Severin J, Ureta-Vidal A, Heng L, Durbin R, et al. EnsemblCompara GeneTrees: Complete, duplication-aware phylogenetic trees in vertebrates. Genome Res. 2009;19(2):327–335. doi: 10.1101/gr.073585.107. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 10.Penel S, Arigon AM, Dufayard JF, Sertier AS, Daubin V, et al. Databases of homologous gene families for comparative genomics. BMC Bioinformatics. 2009;10(Suppl 6):S3. doi: 10.1186/1471-2105-10-S6-S3. doi: 10.1186/1471-2105-10-S6-S3. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 11.Tatusov RL, Koonin EV, Lipman DJ. A genomic perspective on protein families. Science. 1997;278(5338):631–637. doi: 10.1126/science.278.5338.631. [DOI] [PubMed] [Google Scholar]
- 12.Overbeek R, Fonstein M, D'Souza M, Pusch GD, Maltsev M. The use of gene clusters to infer functional coupling. Proc Natl Acad Sci USA. 1999;96(6):2896–2901. doi: 10.1073/pnas.96.6.2896. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 13.Enright AJ, Van Dongen S, Ouzounis CA. An efficient algorithm for large-scale detection of protein families. Nucleic Acids Res. 2002;30(7):1575–1584. doi: 10.1093/nar/30.7.1575. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 14.Li L, Stoeckert CJ, Jr, Roos DS. OrthoMCL: Identification of Ortholog Groups for Eukaryotic Genomes. Genome Res. 2003;13(9):2178–2189. doi: 10.1101/gr.1224503. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 15.Tatusov RL, Fedorova ND, Jackson JD, Jacobs AR, Kiryutin B, et al. The COG database: an updated version includes eukaryotes. BMC Bioinformatics. 2003;4:41. doi: 10.1186/1471-2105-4-41. doi: 10.1186/1471-2105-4-41. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 16.O'Brien KP, Remm M, Sonnhammer ELL. Inparanoid: a comprehensive database of eukaryotic orthologs. Nucl Acids Res. 2005;33(suppl 1):D476–D480. doi: 10.1093/nar/gki107. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 17.Alexeyenko A, Tamas I, Liu G, Sonnhammer ELL. Automatic clustering of orthologs and inparalogs shared by multiple proteomes. Bioinformatics. 2006;22(14):e9–e15. doi: 10.1093/bioinformatics/btl213. [DOI] [PubMed] [Google Scholar]
- 18.DeLuca TF, Wu IH, Pu J, Monaghan T, Peshkin L, et al. Roundup: a multi-genome repository of orthologs and evolutionary distances. Bioinformatics. 2006;22(16):2044–2046. doi: 10.1093/bioinformatics/btl286. [DOI] [PubMed] [Google Scholar]
- 19.Fu Z, Chen X, Vacic V, Nan P, Zhong Y, et al. MSOAR: A High-Throughput Ortholog Assignment System Based on Genome Rearrangement. J Comput Biol. 2007;14(9):1160–1175. doi: 10.1089/cmb.2007.0048. [DOI] [PubMed] [Google Scholar]
- 20.Berglund AC, Sjölund E, Östlund G, Sonnhammer ELL. InParanoid 6: eukaryotic ortholog clusters with inparalogs. Nucl Acids Res. 2008;36(suppl 1):D263–D266. doi: 10.1093/nar/gkm1020. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 21.Fu Z, Jiang T. Clustering of Main Orthologs for Multiple Genomes. J Bioinform Comput Biol. 2008;6(3):573–584. doi: 10.1142/s0219720008003540. [DOI] [PubMed] [Google Scholar]
- 22.Jensen LJ, Julien P, Kuhn M, von Mering C, Muller J, et al. eggNOG: automated construction and annotation of orthologous groups of genes. Nucleic Acids Res. 2008;36(suppl 1):D250–D254. doi: 10.1093/nar/gkm796. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 23.Roth ACJ, Gaston H, Gonnet GH, Dessimoz C. Algorithm of OMA for large-scale orthology inference. BMC Bioinformatics. 2008;9:518. doi: 10.1186/1471-2105-9-518. doi: 10.1186/1471-2105-9-518. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 24.Blom J, Albaum SP, Doppmeier D, Pühler A, Vorhölter FJ, et al. EDGAR: A software framework for the comparative analysis of prokaryotic genomes. BMC Bioinformatics. 2009;10:154. doi: 10.1186/1471-2105-10-154. doi: 10.1186/1471-2105-10-154. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 25.Shi G, Zhang L, Jiang T. MSOAR 2.0: Incorporating tandem duplications into ortholog assignment based on genome rearrangement. BMC Bioinformatics. 2010;11:10. doi: 10.1186/1471-2105-11-10. doi: 10.1186/1471-2105-11-10. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 26.Koski LB, Golding GB. The Closest BLAST Hit Is Often Not the Nearest Neighbor. J Mol Evol. 2011;52(6):540–542. doi: 10.1007/s002390010184. [DOI] [PubMed] [Google Scholar]
- 27.Chen F, Mackey AJ, Vermunt JK, Roos DS. Assessing Performance of Orthology Detection Strategies Applied to Eukaryotic Genomes. PLoS ONE. 2007;2(4):e383. doi: 10.1371/journal.pone.0000383. doi: 10.1371/journal.pone.0000383. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 28.Altenhoff AM, Dessimoz C. Phylogenetic and Functional Assessment of Orthologs Inference Projects and Methods. PLoS Comput Biol. 2009;5(1):e1000262. doi: 10.1371/journal.pcbi.1000262. doi: 10.1371/journal.pcbi.1000262. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 29.Lapierre P, Gogarten JP. Estimating the size of the bacterial pan-genome. Trends Genet. 2009;25(3):107–110. doi: 10.1016/j.tig.2008.12.004. [DOI] [PubMed] [Google Scholar]
- 30.Charlebois RL, Clarke GDP, Beiko RG, St Jean A. Characterization of species-specific genes using a flexible, web-based querying system. FEMS Microbiol Lett. 2003;225(2):213–20. doi: 10.1016/S0378-1097(03)00512-3. [DOI] [PubMed] [Google Scholar]
- 31.Siew N, Fischer D. Twenty thousand ORFan microbial protein families for the biologist? Structure. 2003;11(1):7–9. doi: 10.1016/s0969-2126(02)00938-3. [DOI] [PubMed] [Google Scholar]
- 32.Wilson GA, Bertrand N, Patel Y, Hughes JB, Feil EJ, et al. Orphans as taxonomically restricted and ecologically important genes. Microbiology. 2005;151(Pt 8):2499–2501. doi: 10.1099/mic.0.28146-0. [DOI] [PubMed] [Google Scholar]
- 33.Siew N, Fischer D. On the origin of microbial ORFans: quantifying the strength of the evidence for viral lateral transfer. BMC Evol Biol. 2006;6:63. doi: 10.1186/1471-2148-6-63. doi: 10.1186/1471-2148-6-63. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 34.Koonin EV, Wolf YI. Genomics of bacteria and archaea: the emerging dynamic view of the prokaryotic world. Nucl Acids Res. 2008;36(21):6688–6719. doi: 10.1093/nar/gkn668. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 35.Larkin MA, Blackshields G, Brown NP, Chenna R, McGettigan PA, et al. ClustalW and ClustalX version 2. Bioinformatics. 2007;23(21):2947–2948. doi: 10.1093/bioinformatics/btm404. [DOI] [PubMed] [Google Scholar]
- 36.Thompson JD, Plewniak F, Ripp R, Thierry JC, Poch O. Towards a reliable objective function for multiple sequence alignments. J Mol Biol. 2001;314(4):937–951. doi: 10.1006/jmbi.2001.5187. [DOI] [PubMed] [Google Scholar]
- 37.Ciccarelli FD, Doerks T, von Mering C, Creevey CJ, Snel B, et al. Toward Automatic Reconstruction of a Highly Resolved Tree of Life. Science. 2006;311(5765):1283–1287. doi: 10.1126/science.1123061. [DOI] [PubMed] [Google Scholar]
- 38.Makarova KS, Aravind L, Galperin MY, Grishin NV, Tatusov RL, et al. Comparative genomics of the Archaea (Euryarchaeota): evolution of conserved protein families, the stable core, and the variable shell. Genome Res. 1999;9(7):608–628. [PubMed] [Google Scholar]
- 39.Snel B, Bork P, Huynen MA. Genomes in Flux: The Evolution of Archaeal and Proteobacterial Gene Content. Genome Res. 2002;12(1):17–25. doi: 10.1101/gr.176501. [DOI] [PubMed] [Google Scholar]
- 40.Makarova KS, Sorokin AV, Novichkov PS, Wolf YI, Koonin EV. Clusters of orthologous genes for 41 archaeal genomes and implications for evolutionary genomics of archaea. Biology Direct. 2007;2:33. doi: 10.1186/1745-6150-2-33. doi: 10.1186/1745-6150-2-33. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 41.Tettelin H, Masignani V, Cieslewicz MJ, Donati C, Medini D, et al. Genome analysis of multiple pathogenic isolates of Streptococcus agalactiae: Implications for the microbial “pan-genome”. Proc Natl Acad Sci USA. 2005;102(39):13950–13955. doi: 10.1073/pnas.0506758102. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 42.Tettelin H, Riley D, Cattuto C, Medini D. Comparative genomics: the bacterial pan-genome. Curr Opin Microbiol. 2008;11(5):472–477. doi: 10.1016/j.mib.2008.09.006. [DOI] [PubMed] [Google Scholar]
- 43.Deng X, Phillippy A, Li Z, Salzberg S, Zhang W. Probing the pan-genome of Listeria monocytogenes: new insights into intraspecific niche expansion and genomic diversification. BMC Genomics. 2010;11:500. doi: 10.1186/1471-2164-11-500. doi: 10.1186/1471-2164-11-500. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 44.Mira A, Ochman H, Moran NA. Deletional bias and the evolution of bacterial genomes. Trends Genet. 2010;17(10):589–596. doi: 10.1016/s0168-9525(01)02447-7. [DOI] [PubMed] [Google Scholar]
- 45.Lefébure T, Pavinski Bitar PD, Suzuki H, Stanhope MJ. Evolutionary Dynamics of Complete Campylobacter Pan-Genomes and the Bacterial Species Concept. Genome Biol Evol. 2010;2:646–655. doi: 10.1093/gbe/evq048. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 46.Hogg JS, Hu FZ, Janto B, Boissy R, Hayes J, et al. Characterization and modeling of the Haemophilus influenzae core and supragenomes based on the complete genomic sequences of Rd and 12 clinical nontypeable strains. Genome Biol. 2007;8(6):R103. doi: 10.1186/gb-2007-8-6-r103. doi: 10.1186/gb-2007-8-6-r103. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 47.Donati C, Hiller NL, Tettelin H, Muzzi A, Croucher NJ, et al. Structure and dynamics of the pan-genome of Streptococcus pneumoniae and closely related species. Genome Biol. 2010;11(10):R107. doi: 10.1186/gb-2010-11-10-r107. doi: 10.1186/gb-2010-11-10-r107. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 48.Schoen C, Blom J, Claus H, Schramm-Glück A, Brandt P, et al. Whole-genome comparison of disease and carriage strains provides insights into virulence evolution in Neisseria meningitides. Proc Natl Acad Sci USA. 2008;105(9):3473–3478. doi: 10.1073/pnas.0800151105. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 49.Rasko DA, Rosovitz MJ, Myers GS, Mongodin EF, Fricke WF, et al. The Pangenome Structure of Escherichia coli: Comparative Genomic Analysis of E. coli Commensal and Pathogenic Isolates. J Bacteriol. 2008;190(20):6881–6893. doi: 10.1128/JB.00619-08. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 50.Willenbrock H, Hallin PF, Wassenaar TM, Ussery DW. Characterization of probiotic Escherichia coli isolates with a novel pan-genome microarray. Genome Biol. 2007;8(12):R267. doi: 10.1186/gb-2007-8-12-r267. doi: 10.1186/gb-2007-8-12-r267. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 51.Fischer W, Windhager L, Rohrer S, Zeiller M, Karnholz A, et al. Strain-specific genes of Helicobacter pylori: genome evolution driven by a novel type IV secretion system and genomic island transfer. Nucl Acids Res. 2010;38(18):6089–6101. doi: 10.1093/nar/gkq378. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 52.Kislyuk AO, Haegeman B, Bergman NH, Weitz JS. Genomic fluidity: an integrative view of gene diversity within microbial populations. BMC Genomics. 2011;12:32. doi: 10.1186/1471-2164-12-32. doi: 10.1186/1471-2164-12-32. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 53.Kurtz S, Phillippy A, Delcher AL, Smoot M, Shumway M, et al. Versatile and open software for comparing large genomes. Genome Biol. 2004;5(2):R12. doi: 10.1186/gb-2004-5-2-r12. doi: 10.1186/gb-2004-5-2-r12. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 54.Altschul SF, Madden TL, Schäffer AA, Zhang J, Zhang Z, et al. Gapped BLAST and PSI-BLAST: a new generation of protein database search programs. Nucleic Acids Res. 1997;25(17):3389–3402. doi: 10.1093/nar/25.17.3389. [DOI] [PMC free article] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.