Skip to main content

AxPcoords & parallel AxParafit: statistical co-phylogenetic analyses on thousands of taxa

Abstract

Background

Current tools for Co-phylogenetic analyses are not able to cope with the continuous accumulation of phylogenetic data. The sophisticated statistical test for host-parasite co-phylogenetic analyses implemented in Parafit does not allow it to handle large datasets in reasonable times. The Parafit and DistPCoA programs are the by far most compute-intensive components of the Parafit analysis pipeline. We present AxParafit and AxPcoords (Ax stands for Accelerated) which are highly optimized versions of Parafit and DistPCoA respectively.

Results

Both programs have been entirely re-written in C. Via optimization of the algorithm and the C code as well as integration of highly tuned BLAS and LAPACK methods AxParafit runs 5–61 times faster than Parafit with a lower memory footprint (up to 35% reduction) while the performance benefit increases with growing dataset size. The MPI-based parallel implementation of AxParafit shows good scalability on up to 128 processors, even on medium-sized datasets. The parallel analysis with AxParafit on 128 CPUs for a medium-sized dataset with an 512 by 512 association matrix is more than 1,200/128 times faster per processor than the sequential Parafit run. AxPcoords is 8–26 times faster than DistPCoA and numerically stable on large datasets. We outline the substantial benefits of using parallel AxParafit by example of a large-scale empirical study on smut fungi and their host plants. To the best of our knowledge, this study represents the largest co-phylogenetic analysis to date.

Conclusion

The highly efficient AxPcoords and AxParafit programs allow for large-scale co-phylogenetic analyses on several thousands of taxa for the first time. In addition, AxParafit and AxPcoords have been integrated into the easy-to-use CopyCat tool.

Background

One of the basic questions in evolutionary analyses [1] is whether parasites (e.g., lice or Papillomaviruses) or mutualists have co-speciated with their respective hosts (e.g., mammals). The constant accumulation of DNA and AA sequence data coupled with recent advances in tree building software, such as TNT [2], MrBayes [3], GARLI [4] or RAxML [5], allow for large-scale phylogenetic analyses with several hundred or thousand taxa [612]. Thus, large-scale co-phylogenetic studies have also potentially become feasible. However, most common co-phylogenetic tools or methods such as BPA, TreeMap or TreeFitter (see review in [13]) are not able to handle datasets with a large number of taxa or have not been tested in this regard with respect to their statistical properties. Therefore, there is a performance and scalability gap between tools for phylogenetic analysis and meta-analysis. The capability to analyze large datasets is important to infer "deep co-phylogenetic" relationships which could otherwise not be assessed [14].

Parafit [15] implements statistical tests for both overall phylogenetic congruence as well as for the significance of individual associations. Extensive simulations have shown that the Parafit tests are statistically well-behaved and yield acceptable error rates. The method has been successfully applied in a number of biological studies [1619]. In addition, the Type-II statistical error of Parafit decreases with the size of the dataset (see [15]), i.e., this approach scales well on large phylogenies of hosts and associates. Due to these desirable properties, recent work on CopyCat [14] focused on improving the usability of Parafit via a Graphical User Interface (GUI) and automation of the analysis pipeline which transforms phylogenetic trees to patristic (tree-based) distance matrices, converts distance matrices to matrices of eigenvectors using DistPCoA [20], invokes Parafit, and parses input, intermediate, as well as output files. However, co-phylogenetic analyses with CopyCat can not be conducted on large datasets due to the excessive run time requirements of Parafit and DistPCoA, which represent the by far most compute-intensive part of the CopyCat analysis pipeline.

Here we present AxParafit and AxPcoords which are highly optimized and parallelized versions of Parafit and DistPCoA respectively. As outlined by the case-study on smut fungi on page 6 these accelerated programs allow for more thorough large-scale co-phylogenetic analyses and extend the applicability of the approach by 1–2 orders of magnitude, thus closing the aforementioned performance gap concerning current phylogenetic meta-analysis tools. Coupled with the easy-to-use CopyCat tool AxParafit/AxPcoords facilitate statistical co-phylogenetic analyses on the largest trees that can currently be computed.

Implementation

For programming convenience and portability as well as due to the structure of the original Fortran code we re-implemented Parafit and DistPCoA in C from scratch.

Sequential Optimization

The sequential C code was optimized by reducing unnecessary memory allocations for matrices in AxPcoords/AxParafit and using a faster method to permute matrices in AxParafit.

Thereafter the compute-intensive for-loops in AxParafit/AxPcoords were manually tuned. After those initial optimizations we profiled both programs and found that the run-times were now largely dominated (over 90% of total execution time) by a dense matrix-matrix multiplication in AxParafit and the computation of eigenvectors/eigenvalues in AxPcoords respectively. To further accelerate the programs we integrated function calls to the highly optimized matrix multiplication of the BLAS (Basic Linear Algebra Package [21]) package and eigenvector/eigenvalue decomposition in LAPACK (Linear Algebra PACKage [22]).

For BLAS we assessed the usage of ATLAS BLAS (Automatically Tuned Linear Algebra Software, math-atlas.sourceforge.net) as well as the ACML BLAS (AMD Core Math Library [23]) libraries on a 2.4 GHz AMD Opteron CPU. The ACML package showed slightly faster speeds (≈ 7–9%). However, AxParafit also provides an interface to the INTEL MKL (Math Kernel Library) and ATLAS BLAS implementations. AMD ACML, INTEL MKL, and ATLAS are all freely available for academic use. AxParafit can also be compiled without BLAS and rely on a manually tuned matrix multiplication which is approximately 4 times slower.

AxPcoords can use either the LAPACK functions implemented in the AMD ACML or INTEL MKL libraries. In addition, AxPcoords can also make use of the GNU scientific library [24] for eigenvector/eigenvalue computations.

The tuned programs were designed to yield exactly the same results as Parafit and DistPCoA. Note however, that in contrast to AxPcoords we observed numerically unstable results for DistPCoA on datasets with large association matrices, containing more than 4,096 entries. This is due to some well-known problems with the stability of eigenvector/eigenvalue decomposition [2527] on large datasets and due to the fact that the original Parafit code uses the algorithm from [28]. Therefore, the integration of the thoroughly tested LAPACK routines, apart from speed benefits, also yields increased numerical stability. We integrated AxPcoords and AxParafit into CopyCat [14]. Figure 1 provides a screen-shot of CopyCat whit a drop-down menu that allows the user to select AxParafit/AxPcoords for executing the analyses.

Figure 1
figure 1

Screen-shot of AxParafit/AxPcoords Option in CopyCat. This screen-shot shows the CopyCat drop-down menu that allows the user to select AxParafit/AxPcoords for executing the analyses and to switch between the U and W modes of branch length computation.

Parallelization

AxPcoords requires less than 24 hours of run-time on a single CPU, even for distance matrices with several thousands of taxa. Therefore, we exclusively focused on the parallelization of AxParafit which requires run-times of several days or weeks on large datasets.

The execution time of Parafit depends on the sizes of input matrices A, B, and C with dimensions n1n2, n4n1, and n3n2 respectively (for details see [15]). The complexity is roughly O(nonZero(A)n3n4n1p). The term n3n4n1 is the complexity of the dense matrix multiplication in AxParafit. The variable p is the user-specified number of permutations that shall be executed (typically 99–9,999, not counting the original permutation) and nonZero(A) is the number of non-zero elements in the binary association matrix A. The program executes two main steps: the global test of co-speciation with complexity O(n3n4n1p) and the individual tests with complexity O(nonZero(A)n3n4n1p). Since in real-world analyses nonZero(A) 1 we only parallelized all individual tests of co-speciation which typically generate over 99% of the total computational load. Our approach represents a trade-off between the amount of programming effort required for the parallelization and the expected performance gains. Thus, initially the global test of co-speciation must be executed using the sequential version of AxParafit. The sequential program provides an option to conduct the global test, write a binary output file that can be used to start the parallel computation of individual host-parasite links, and then exit.

The statistical test of individual associations has been parallelized with MPI (Message Passing Interface) via a master-worker scheme. The parallelization is straight-forward since all tests of individual associations are independent from one another and can thus be computed independently on individual workers. Moreover, each individual test has approximately the same execution time, such that there are no problems due to load imbalance. The maximum number of CPUs that can be used by our parallelization is thus nonZero(A). However, this can be improved by using the ACML or MKL BLAS implementations that exploit fine-grained loop level parallelism on SMP (Symmetric Multi-Processing) architectures. This allows for a more efficient utilization of hybrid supercomputer architecture. Moreover, it might help to improve performance on huge datasets where SMP implementations can profit from super-linear speedups due to increased cache efficiency.

Results and Discussion

The current Section is split into two parts: Part 1 describes the computational results while Part 2 outlines the substantial benefits of using AxParafit for large-scale empirical co-phylogenetic studies.

Computational Performance

Here we provide performance data regarding the purely computational aspects of AxParafit.

Experimental Setup

To conduct computational experiments we used an unloaded system of 36 4-way AMD 2.4 GHz Opteron processors with 8 GB of main memory per node which are interconnected by an Infiniband switch. Parafit and DistPCoA were compiled using g77 -ffixed-line-length-0 -ff90-intrinsics-delete -03. AxParafit and AxPcoords were compiled with -03 -fomit-frame-pointer -funroll-loops and linked with the AMD ACML library. We also assessed additional compiler optimizations (-fomit-frame-pointer, -funroll-loops, -m64, -march = k8) with g77 for Fortran, which actually lead to performance decrease of Parafit and DistPCoA (data not shown).

In order to assess performance of AxParafit we extracted subsets from a large empirical dataset with more than 30,000 host-associate links (collected from entries in the EMBL database [29]), which we are currently analyzing with our tools. We sampled square association matrices A, i.e., n1 = n2 of dimensions 128, 256, 512, 1,024, and 2,048. The number nonZero(A) was 128, 256, 512, 1,024, and 2,048 respectively. The number of permutations p was set to 99, 99, 9, 2, and 2 respectively. A complete test on the dataset of size 4,096 was not conducted with Parafit due to the extremely long run-times on n1 = n2 = 2, 048 which already amounts to 19.9 days compared to 7.7 hours required by AxParafit.

To test AxPcoords we used the same compiler switches as indicated above and a subset of the square association matrices with nonZero(A) amounting to 512, 1,024, 2,048, and 4,096 respectively.

Results

In Figure 2 we provide the sequential run-time improvement of AxParafit over Parafit. The acceleration obtained by AxParafit increases with growing dataset size and attains a factor of 61.86 on the association matrix of size 2,048. The increase of the performance improvement with growing dataset size is mainly due the larger efficiency of both our own optimizations as well as the cache blocking strategies used in the BLAS implementations.

Figure 2
figure 2

Run Time Improvement Sequential AxParafit versus Parafit. Run-time improvement of AxParafit versus Parafit for quadratic association matrices of dimensions 128, 256, 512, 1,024, and 2,048.

Figure 3 provides the memory use of AxParafit and Parafit in MB for quadratic A-matrices of sizes 128, 256, 512, 1,024, 2,048, and 4,096 (note that the dataset of size 4,096 was not run to completion). To test AxPcoords we used distance matrices of sizes 512, 1,024, 2,048, and 4,096. Run-time improvements range from 8.8 to 25.74. The run on 4,096 with DistPCoA apparently terminated but did not write a results file, most probably due to numerical instability (Pierre Legendre, personal communication). Figure 4 shows the run-time improvement of AxPcoords over DistPCoA for quadratic distance matrices of sizes 512, 1,024, 2,048, and 4,096. As already mentioned, the run on 4,096 with DistPCoA did not write a results file. Tests on smaller distance matrices e.g., of size 128 and 256 were omitted due to the low execution times which were below 10 seconds. On the largest matrix AxPcoords terminated within only 399 seconds as opposed to 10,268 seconds required by DistPCoA.

Figure 3
figure 3

Memory Consumption AxParafit versus Parafit. Memory consumption of Parafit and AxParafit for quadratic association matrices of size 128, 256, 512, 1,024, 2,048, and 4,096.

Figure 4
figure 4

Run Time Improvement Sequential AxPcoords versus DistPCoA. Run-time improvement of AxPcoords versus DistPCoA for quadratic distance matrices of dimensions 512, 1,024, 2,048, and 4,096.

We assessed scalability of parallel AxParafit using the association matrix A of size 512 on 4, 8, 16, 32, 64, and 128 processors with p = 99. Figure 5 provides the speedup with respect to the number of worker processes. We indicate speedup values for the parallel part (SpeedupIndividual, computation of individual host-parasite links) as well as for the sequential plus the parallel part of the program (SpeedupWhole), i.e., we added the sequential computation time for the global test to the parallel execution time. On 128 processors the computation took only 50 seconds. An analysis of this dataset with the sequential version of Parafit would take approximately 20 hours.

Figure 5
figure 5

Speedup of Parallel AxParafit. Speedup of parallelized part and speedup for sequential plus parallel part of AxParParafit for a quadratic association matrix of size 512 on 4, 8, 16, 32, 64 and 128 CPUs.

A Real-World Example

In order to provide an example for the substantial benefits of performing a large-scale co-phylogenetic analysis with AxParafit we provide a real-world study on smut fungi and their host plants.

Experimental Data

We collected a large sample of associations of smut fungi and their host plants. Smut fungi comprise more than 1,500 species of obligate phytoparasites and are arranged in the taxa Entorrhizomycetes, Microbotryales, and Ustilaginomycotina. These parasites cause syndromes such as dark, powdery appearance of the mature spore masses or may even lead to plant deformation in some cases [30, 31]. The Ustilaginomycotina also comprise obligate plant parasites with distinct morphology [30].

With a few exceptions, hosts of smut fungi belong to the Angiosperms [30]. For economically important hosts, such as barley and other cereals, smut fungi may cause considerable yield losses (see e.g., [32]). Phylogeny and taxonomy of genera and higher ranks has been derived from sound molecular and ultrastructural data in recent years (see [30] and references therein). However, apart from the work presented in [14], co-phylogenetic analysis of smut fungi have so far been restricted to single genera with comparatively few species [33, 34].

In addition to the host plant index for European smut fungi [31, 35] that has been used in [14], information on smut fungus-host plant associations was extracted from the following publications: Bauer et al. [3638], Begerow et al. [33, 39], De Beer et al. [40], Hendrichs et al. [41], Nannfeldt [42], Piepenbring [43], Scholz and Scholz [44], an unpublished manuscript by K. Vanky (Smut fungi of the Indian subcontinent; Vanky, personal communication), and Vanky and McKenzie [45]. Moreover, we included information contained in the "specific host" entries of the complete collection of core nucleotide sequences for Entorrhizomycetes, Microbotryales, and Ustilaginomycotina downloaded from GenBank [46] on September 01, 2007 (12,815 sequences). Parasite taxon names were corrected using Vanky's synonym-list [35]. Synonyms for host taxon names were obtained from Palese and Moser [47].

Including synonyms, our data set contained 3,912 different fungus-plant associations. In order to retrieve taxon IDs and to construct taxonomy trees for hosts and parasites [14], we used the NCBI taxonomy release of September 01, 2007. For host and parasite species names that were not found in the NCBI taxonomy, the search was repeated after reducing the taxon name to the respective genus. In this way, a total of 2,362 different associations could be identified that covers 413 smut fungi and 1,400 host plants. Thus, the dataset assembled was more than three times larger than the one recently analyzed in [14], which contained 645 associations, corresponding to 140 smut fungi and 437 host plants. The Parafit analysis of this comparatively small dataset took already more than a week. For both hosts and parasites, two trees were constructed, one tree with branch lengths corresponding to the "true" (denoted as W for Weighted) taxonomical distance [14] and one with all branch lengths set to 1 (denoted as U for Un-weighted/Uniform). As outlined on page 4 the computational complexity of AxParafit is O(nonZero(A)n3n4n1p) and thus the execution time requirements for this larger dataset increase significantly.

Inference with AxParafit

Production runs with Parafit and AxParafit on an initial version of our dataset were started on August 29, 2007. While the Parafit inferences with 99 permutations on this initial dataset were still running at the time of writing this manuscript(September 9, 2007), the parallel AxParafit run with 99 permutations terminated within less than 480 seconds on 128 CPUs of the Infiniband cluster. This made the results available immediately and allowed us to identify a bug in the data collection script. The buggy version of this script did not take the presence of non-unique scientific taxon names, (e.g.,Setaria (Magnoliophyta, Poales) and Setaria (Nematoda, Filarioidea)) into account to identify NCBI taxon IDs. Such errors are unfortunately typical and frequent in Bioinformatics analysis pipelines. As a typical example of such errors consider the retraction of "Measures of Clade Confidence Do Not Correlate with Accuracy of Phylogenetic Trees" by Barry G. Hall due to an error in a perl script [48].

In addition to the rapid detection of input data errors, the significant performance gains obtained by sequential optimization and parallelism allow for the assessment of different program parameters and analysis options, such as trees with different patristic distances (U and W trees) as well as the impact of the number of permutations on the results (AxParafit was run with 99/999/9,999 permutations on the U and W data), i.e., a significantly more thorough and detailed analysis.

The absolute execution times for AxParafit on 128 CPUs for 99/999/9,999 permutations are indicated in Table 1. Essentially, 99 permutations could be conducted within 7 minutes, 999 permutations in much less than 2 hours, and 9,999 permutations overnight in about 12 hours such that the whole study, including the detection of the script error and the analysis of the results could be completed in less than a week. As indicated in Table 2 there are a number of links (max. 48 out of 2,362 ≈ 2%) that are not uniformly significant or uniformly insignificant at low p-values between analyses with a distinct number of permutations. AxParafit therefore allows for rapid and much more thorough computation and analyses of large co-phylogenetic datasets. The results indicate that U-based analyses are in general more sensitive to the number of permutations than W-based runs. Note that the number of host/parasite eigenvectors for U (1,390/411) was higher than for W (1,200/372), which explains the longer execution times and potentially the larger differences in significance values.

Table 1 Empirical Data Study: Parallel AxParafit Execution Times
Table 2 Empirical Data Study: Impact of the Number of Permutations

Table 3 indicates the number of different significant links between the U- and W-based analyses for various p-values. The table indicates that there is no clear tendency for differences to decrease with increasing number of permutations.

Table 3 Empirical Data Study: Differences between U and W-based Analyses

Biological Interpretation of Results

In the following, we focus on the results obtained with 9,999 permutations and branch lengths scaled in terms of taxonomical distances (W-labeled results). The global test indicates a highly significant co-phylogenetic relationship (p = 0.0001). An overview of the results for individual host-parasite links based on the smut fungi genera is provided in Figure 6. Major taxonomic groups of host and parasites are indicated according to the NCBI taxonomy release used. Based on a significance threshold of p = 0.05 and the ParafitLink1 statistics [15], a total of 578 insignificant and 1,784 significant associations is obtained. As in our earlier study [14], genera of smut fungi are rather uniform with respect to their significance values, which facilitates the identification of a general distribution pattern with respect to significant and insignificant links, i.e., the "deep co-phylogeny" of smut fungi.

Figure 6
figure 6

Overview of the Results for Individual Host-Parasite Links based on the Smut Fungi Genera. Major taxonomic groups of host and parasites are indicated according to the NCBI taxonomy release used. Significant and insignificant associations are indicated as [S] or [I] respectively. Stars denote to doubtful associations.

The single most important factor appears to be whether the hosts belong to the monocots (i.e.,Liliopsida) or not. Entorrhiza species, which are taxonomically isolated, mostly are linked with monocots (Poales) and do thus not contribute significantly to the overall fit between host and parasite phylogenies. In the case of Microbotryales, the majority of taxa are pathogenic of core eudicots, resulting in significant links. Fewer associations with monocots (mostly Poales) are present, which are considered insignificant. The same pattern can be observed in the class Exobasidiomycetes within Ustilaginomycotina: A minority of host-parasite links is within monocots (Poales, but also other orders), which are considered insignificant, whereas the associations with other hosts (Selaginellales, basal Magnoliophyta, magnoliids, and stem and core eudicots) are significant. Inverse relationships are present in the class Ustilaginomycetes within Ustilaginomycotina. Here, most species infect monocots, mainly Poales, significantly increasing the congruence between host and parasite taxonomy trees, whereas the associations with core eudicots appear to be insignificant.

Accordingly, the current analysis that is based on a considerably larger empirical sample (e.g., 66 instead of 25 included genera of smut fungi) confirms earlier results [14]. Therefore, we can generalize the observation that the difference between Poales and non-Poales hosts is crucial for the distribution of significance values to the distinction between monocot and non-monocot hosts. We also observe a small number of exceptions from this general pattern. For instance, in Urocystis (Ustilaginomycetes), which occurs on a variety of host groups, the links with stem eudicots (species of Ranunculaceae) are significant, and a single link with monocots (PACCAD clade within Poaceae) is judged as insignificant. Thus, rather subtle details of the host-parasite relationships, such as the presence of Urocystis on several closely related Ranunculaceae hosts and its presence on distantly related hosts within Poaceae, are recognized by the AxParafit algorithm, and the uniform overall pattern does not merely reflect the relatively low topological resolution present in the taxonomy trees.

Some of the results obtained may also be due to flaws in the taxonomy of the species included, particularly in the nomenclature of the parasites. For instance, Entorrhiza isoetis is most likely conspecific with Ustilago isoetis [31]. At present it is even doubtful whether this species belongs to smut fungi (R. Bauer, personal communication). Thus, the associations with Isoetes (Lycopodiophyta) mentioned in Scholz and Scholz [44], which show different significance values than the majority of hosts links in either Ustilago or Entorrhiza, are dubious. Likewise, the exceptional associations of Entyloma with monocots are probably due to species names that would need to be recombined into genera of the Georgefischeriales [37]. Whereas these flaws have to be corrected by considering more comprehensive lists of species and synonyms in monographs and in future releases of the NCBI database, it is apparent that neither the highly significant overall co-phylogenetic relationship nor the general pattern regarding individual host-smut fungus links would be affected by the removal of the doubtful associations. Rather, their influence is overcome by the large total sample size; for each parasite genus dubious links are few relative to the total number of links or not present at all. Likewise, there are few differences in the significance between analyses with a distinct number of permutations (see Table 2). Discrepancies between U and W are also comparatively small (see Table 3). With 9,999 permutations, they are restricted to four genera of smut fungi and only affect hosts, such as Urocystis on monocots in Asparagales and Dioscoreales (details not shown), with an intermediate taxonomic position.

The analysis process presented here underlines the advantage of the large-scale approach to co-phylogenetic tests, that is enabled by AxPcoords/AxParafit. Furthermore, because many problems are more easily recognized after conducting preliminary runs, re-analysis after applying corrective measures may be necessary for many empirical datasets. Thus, efficient implementations and parallelism are of great practical importance for the analysis pipeline.

Conclusion

We have produced highly optimized and efficient implementations of the two most compute-intensive components for P. Legendre's statistical test of host-parasite co-speciation. The parallel implementation of AxParafit scales well up to 128 CPUs on a medium-size dataset. AxParafit and AxPcoords have been integrated into the CopyCat tool and are freely available for download as open source code.

Future work will mainly cover large-scale production runs with AxParafit.

Availability and Requirements

The source code and some of the test datasets are available at ic http://www.epfl.ch/~stamatak/AxParafit.html.

The datasets and results of the empirical study on smut fungi are also available at this site. It also provides several pre-compiled binaries for Windows, MAC, and Linux/Unix platforms.

AxParafit can be compiled as stand-alone application without making use of either ATLAS, MKL or ACML. AxPcoords requires either MKL, ACML, or the GNU scientific library.

The new CopyCat version that uses AxParafit and AxPcoords is available at http://www-ab.informatik.uni-tuebingen.de/software/copycat/review.

References

  1. Page RDM: Tangled Trees. Phylogeny, Cospeciation and Coevolution. The University of Chicago Press; 2002. chap. Introduction chap. Introduction

    Google Scholar 

  2. Goloboff P: Analyzing large data sets in reasonable times: solution for composite optima. Cladistics 1999, 15: 415–428. 10.1111/j.1096-0031.1999.tb00278.x

    Article  Google Scholar 

  3. Ronquist F, Huelsenbeck J: MrBayes 3: Bayesian phylogenetic inference under mixed models. Bioinformatics 2003, 19(12):1572–1574. 10.1093/bioinformatics/btg180

    Article  CAS  PubMed  Google Scholar 

  4. Zwickl D: Genetic Algorithm Approaches for the Phylogenetic Analysis of Large Biological Sequence Datasets under the Maximum Likelihood Criterion. PhD thesis. University of Texas at Austin; 2006.

    Google Scholar 

  5. Stamatakis A: RAxML-VI-HPC: maximum likelihood-based phylogenetic analyses with thousands of taxa and mixed models. Bioinformatics 2006, 22(21):2688–2690. 10.1093/bioinformatics/btl446

    Article  CAS  PubMed  Google Scholar 

  6. Grimm GW, Renner SS, Stamatakis A, Hemleben V: A Nuclear Ribosomal DNA Phylogeny of Acer Inferred with Maximum Likelihood, Splits Graphs, and Motif Analyses of 606 Sequences. Evolutionary Bioinformatics Online 2006, 2: 279–294.

    CAS  Google Scholar 

  7. McMahon MM, Sanderson MJ: Phylogenetic Supermatrix Analysis of GenBank Sequences from 2228 Papilionoid Legumes. Systematic Biology 2006, 55(5):818–836. 10.1080/10635150600999150

    Article  PubMed  Google Scholar 

  8. Bininda-Emonds ORP, Cardillo M, Jones KE, MacPhee RDE, Beck RMD, Grenyer R, Price SA, Vos RA, Gittleman JL, Purvis A: The delayed rise of present-day mammals. Nature 2007, 446: 507–512. 10.1038/nature05634

    Article  CAS  PubMed  Google Scholar 

  9. DeSantis TZ, Hugenholtz P, Larsen N, Rojas M, Brodie EL, Keller K, Huber T, Dalevi D, Hu P, Andersen GL: Greengenes, a Chimera-Checked 16S rRNA Gene Database and Workbench Compatible with ARB. Applied Environmental Microbiology 2006, 72(7):5069–5072. 10.1128/AEM.03006-05

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  10. Soltis DE, Gitzendanner MA, Soltis PS: A 567-taxon data set for angiosperms: The challenges posed by bayesian analyses of large data sets. International Journal of Plant Sciences 2007, 168(2):137–157. 10.1086/509788

    Article  CAS  Google Scholar 

  11. Robertson CE, Harris JK, Spear JR, Pace NR: Phylogenetic diversity and ecology of environmental Archaea . Current Opinion in Microbiology 2005, 8: 638–642.

    Article  CAS  PubMed  Google Scholar 

  12. Ley RE, Harris JK, Wilcox J, Spear JR, Miller SR, Bebout BM, Maresca JA, Bryant DA, Sogin ML, Pace NR: Unexpected Diversity and Complexity of the Guerrero Negro Hypersaline Microbial Mat. Applied Environmental Microbiology 2006, 72(5):3685–3695. 10.1128/AEM.72.5.3685-3695.2006

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  13. Stevens J: Computational aspects of host-parasite phylogenies. Briefings in Bioinformatics 2004, 5(4):339–349. 10.1093/bib/5.4.339

    Article  CAS  PubMed  Google Scholar 

  14. Meier-Kolthoff JP, Auch AF, Huson DH, Göker M: COPYCAT: Co-phylogenetic analysis tool. Bioinformatics 2007, 23(7):898–900. 10.1093/bioinformatics/btm027

    Article  CAS  PubMed  Google Scholar 

  15. Legendre P, Desdevises Y, Bazin E: A statistical test for host-parasite coevolution. Systematic Biology 2002, 51(2):217–234. 10.1080/10635150252899734

    Article  PubMed  Google Scholar 

  16. Ricklefs R, Fallon S, Birmingham E: Evolutionary relationships, cospeciation, and host switching in avian malaria parasites. Systematic Biology 2004, 53: 111–119. 10.1080/10635150490264987

    Article  PubMed  Google Scholar 

  17. Hansen H, Bachmann L, Bakke T: Mitochondrial DNA variation of Gyrodactylus spp. ( Monogenea, Gyrodactylidae ) populations infecting Atlantic salmon, grayling, and rainbow trout in Norway and Sweden. International Journal of Parasitology 2003, 33(13):1471–1478. 10.1016/S0020-7519(03)00200-5

    Article  CAS  PubMed  Google Scholar 

  18. Meinilä M, Kuusela J, Zietara MS, Lumme J: Initial steps of speciation by geographic isolation and host switch in salmonid pathogen Gyrodactylus salaris ( Monogenea: Gyrodactylidae ). International Journal of Parasitology 2004, 34(4):515–526. 10.1016/j.ijpara.2003.12.002

    Article  PubMed  Google Scholar 

  19. Huyse T, Audenart V, Volckaert FA: Speciation and host-parasite relationships in the parasite genus Gyrodactylus ( Monogenea, Platyhelminthes ) infecting gobies of the genus Pomatoschistus ( Gobiidae, Teleostei ). International Journal Parasitology 2003, 33(14):1679–1689. 10.1016/S0020-7519(03)00253-4

    Article  Google Scholar 

  20. Legendre P, Anderson MJ: Program DistPCoA. Département de sciences biologiques, Université de Montréal; 1998.

    Google Scholar 

  21. Basic Linear Algebra Package[http://www.netlib.org/blas]

  22. Linear Algebra PACKage[http://www.netlib.org/lapack]

  23. AMD Core Math Library[http://www.amd.com/acml]

  24. GNU scientific library[http://www.gnu.org/software/gsl]

  25. Bai Z, Fahey M, Golub G: Some large-scale matrix computation problems. Journal of Computational and Applied Mathematics 1996, 74: 71–89. 10.1016/0377-0427(96)00018-0

    Article  Google Scholar 

  26. Griffith DA: Eigenfunction properties and approximations of selected incidence matrices employed in spatial analyses. Linear Algebra and its Applications 2000, 321: 95–112. 10.1016/S0024-3795(00)00031-8

    Article  Google Scholar 

  27. Bollhöfer M, Notay Y: JADAMILU: a code for computing selected eigenvalues of large sparse symmetric matrices. Tech rep Université Libre de Bruxelles, Brussels; 2006. [http://homepages.ulb.ac.be/~jadamilu/]

    Google Scholar 

  28. Press WH, Teukolsky SA, Vetterling WT, Flannery BP: Numerical Recipes in C. Cambridge University Press; 1992.

    Google Scholar 

  29. EMBL database[http://www.ebi.ac.uk/embl]

  30. Bauer R, Begerow D, Oberwinkler F, Piepenbring M, Berbee M: Ustilaginomycetes . The Mycota 2001, 7(Part B):57–83.

    Google Scholar 

  31. Vanky K: European Smut Fungi. G. Fischer; 1994.

    Google Scholar 

  32. Thomas P, Menzies J: Cereal smuts in Manitoba and Saskatchewan, 1989–95. Canadian Journal of Plant Pathology 1997, 19(2):161–165.

    Article  Google Scholar 

  33. Begerow D, Bauer R, Oberwinkler F: The Exobasidiales : An evolutionary hypothesis. Mycological Progress 2002, 1(2):187–199. 10.1007/s11557-006-0018-7

    Article  Google Scholar 

  34. Jackson A: A Reconciliation Analysis of Host Switching in Plant-Fungal Symbioses. Evolution 2004, 58(9):1909–1923.

    Article  PubMed  Google Scholar 

  35. Vanky K: European Smut Fungi ( Ustilaginomycetes p.p. and Microbotryales ) according to recent nomenclature. Mycologia Balcanica 2005, 2: 169–178.

    Google Scholar 

  36. Bauer R, Vanky K, Begerow D, Oberwinkler F: Ustilaginomycetes on Selaginella . Mycologia 1999, 91(3):475–484. 10.2307/3761348

    Article  Google Scholar 

  37. Bauer R, Begerow D, Nagler A, Oberwinkler F: The Georgefischeriales : A Phylogenetic Hypothesis. Mycological Research 2001, 105(04):416–424. 10.1017/S0953756201003690

    Article  Google Scholar 

  38. Bauer R, Lutz M, Oberwinkler F: Gjaerumia , a new genus in the Georgefischeriales ( Ustilaginomycetes ). Mycological Research 2005, 109(11):1250–1258. 10.1017/S0953756205003783

    Article  CAS  PubMed  Google Scholar 

  39. Begerow D, Bauer R, Oberwinkler F: Muribasidiospora: Microstromatales or Exobasidiales ? Mycological Research 2001, 105(07):798–810. 10.1017/S0953756201004208

    Article  Google Scholar 

  40. de Beer Z, Begerow D, Bauer R, Pegg G, Crous P, Wingfield M: Phylogeny of the Quambalariaceae fam. nov., including important Eucalyptus pathogens in South Africa and Australia. Studies in Mycology 2006, 55: 289–298.

    Article  PubMed Central  PubMed  Google Scholar 

  41. Hendrichs M, Bauer R, Oberwinkler F: The Cryptobasidiaceae of tropical Central and South America. Sydowia 2003, 55: 33–64.

    Google Scholar 

  42. Nannfeldt J: Exobasidium , a taxonomic reassessment applied to the European species. Symbolae Botanicae Upsaliensis 1981, 23: 1–72.

    Google Scholar 

  43. Piepenbring M: Smut fungi: ( Ustilaginomycetes p.p. and Microbotryales, Basidiomycota ). Flora Neotropica Monograph 2003, 86: 1–291.

    Google Scholar 

  44. Scholz H, Scholz I: Die Brandpilze Deutschlands ( Ustilaginales ). Englera 1988, (8):1–691. 10.2307/3776736

  45. Vanky K, McKenzie E: Smut fungi of New Zealand. Fungal Diversity Press, Centre for Research in Fungal Diversity, Dept. of Ecology & Biodiversity, University of Hong Kong Hong Kong; 2002.

    Google Scholar 

  46. GenBank[http://www.ncbi.nlm.nih.gov]

  47. Palese R, Moser D: Synonymie-Index der Schweizer Flora und der angrenzenden Gebiete. In Tech rep. Zentrum des Datenverbundnetzes der Schweizer Flora; 1997.

    Google Scholar 

  48. PLOS retraction[http://compbiol.plosjournals.org/perlserv/?request=get-document&doi=10.1371/journal.pcbi.0030158]

Download references

Acknowledgements

We would like to thank Pierre Legendre for his kind and very useful feedback on this manuscript. We would also like to thank Daniel Huson for useful comments on this manuscript. Cordial thanks are addressed to K. Vanky, M. Piepenbring, D. Begerow, R. Bauer, and M. Hendrichs for providing published hosts lists of smut fungi stored electronically and particularly to K. Vanky for giving access to the list of parasites from India. R. Bauer provided helpful additional advice on smut fungi.

AS is funded by Swiss Confederation Funds. Financial support provided by the Deutsche Forschungsgemeinschaft for MG and AFA is gratefully acknowledged.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Alexandros Stamatakis.

Additional information

Authors' contributions

AS ported the programs from Fortran to C, optimized the C code, integrated the BLAS and LAPACK packages, parallelized the program and performed the computational experiments. AFA and JMK carried out the integration into CopyCat. AFA, JMK, and MG assembled the Binaries for various platforms and provided scripts to conduct the computational experiments. MG assembled the test datasets. AS and MG conducted the empirical study on smut fungi and their hosts. AS, AFA, JMK, and MG wrote the manuscript. All authors read and approved the final manuscript

Authors’ original submitted files for images

Rights and permissions

This article is published under license to BioMed Central Ltd. This is an Open Access article distributed under the terms of the Creative Commons Attribution License (http://creativecommons.org/licenses/by/2.0), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited.

Reprints and permissions

About this article

Cite this article

Stamatakis, A., Auch, A.F., Meier-Kolthoff, J. et al. AxPcoords & parallel AxParafit: statistical co-phylogenetic analyses on thousands of taxa. BMC Bioinformatics 8, 405 (2007). https://doi.org/10.1186/1471-2105-8-405

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-8-405

Keywords