apex: phylogenetics with multiple genes (2024)

  • Journal List
  • Wiley-Blackwell Online Open
  • PMC5215480

As a library, NLM provides access to scientific literature. Inclusion in an NLM database does not imply endorsem*nt of, or agreement with, the contents by NLM or the National Institutes of Health.
Learn more: PMC Disclaimer | PMC Copyright Notice

apex: phylogenetics with multiple genes (1)

This ArticleFor AuthorsLearn MoreSubmit

Molecular Ecology Resources

Mol Ecol Resour. 2017 Jan; 17(1): 19–26.

Published online 2016 Aug 12. doi:10.1111/1755-0998.12567

PMCID: PMC5215480

PMID: 27417145

Thibaut Jombart,apex: phylogenetics with multiple genes (2)1 Frederick Archer,2 Klaus Schliep,3 Zhian Kamvar,4 Rebecca Harris,5 Emmanuel Paradis,6 Jérome Goudet,7,8 and Hilmar Lapp9

Author information Article notes Copyright and License information PMC Disclaimer

Abstract

Genetic sequences of multiple genes are becoming increasingly common for a wide range of organisms including viruses, bacteria and eukaryotes. While such data may sometimes be treated as a single locus, in practice, a number of biological and statistical phenomena can lead to phylogenetic incongruence. In such cases, different loci should, at least as a preliminary step, be examined and analysed separately. The r software has become a popular platform for phylogenetics, with several packages implementing distance‐based, parsimony and likelihood‐based phylogenetic reconstruction, and an even greater number of packages implementing phylogenetic comparative methods. Unfortunately, basic data structures and tools for analysing multiple genes have so far been lacking, thereby limiting potential for investigating phylogenetic incongruence. In this study, we introduce the new r package apex to fill this gap. apex implements new object classes, which extend existing standards for storing DNA and amino acid sequences, and provides a number of convenient tools for handling, visualizing and analysing these data. In this study, we introduce the main features of the package and illustrate its functionalities through the analysis of a simple data set.

Keywords: genetics, package, phylogenies, r, software

Introduction

The constant improvement of sequencing technologies provides ever‐increasing amounts of genetic sequences for a wide range of organisms including viruses, bacteria and a variety of eukaryotes. As a consequence, organisms are more frequently sequenced for multiple genes, and full‐genome data are becoming increasingly common (Pettersson etal. 2009; Pareek etal. 2011). This is especially true for viruses and bacteria, whose smaller genomes allow for large collections of complete genome sequences to be assembled relatively easily (e.g. Harris etal. 2013; Weinert etal. 2015).

While it is tempting to treat multiple genes as a single evolutionary unit (de Queiroz & Gatesy 2007), a number of biological processes and statistical issues can lead to phylogenetic incongruence, causing different genes to exhibit distinct phylogenies (Wendel & Doyle 1998; Rokas etal. 2003; Pollard etal. 2006; Knowles 2009; Som 2015). Therefore, multiple gene data should ideally be first analysed separately to look for congruent genealogies and then possibly concatenated to derive a single phylogenetic tree. In practice, however, such an approach may not be trivial to implement.

Indeed, handling and analysing multiple gene alignments can be a daunting task. While the r software is growing as a platform of choice for phylogenetic analyses (Paradis etal. 2004; Jombart etal. 2010a; Kembel etal. 2010; Schliep 2011; Popescu etal. 2012), tools for handling and analysing multiple gene data are missing. In this study, we introduce apex, a new r package which fills this gap. apex implements new object classes for storing and handling multiple genes data. This package is fully integrated and compatible with existing r standards for phylogenetic reconstruction and makes the analysis of multiple genes as straightforward as for single genes. In the following, we provide an overview of these functionalities and illustrate the main features using a worked example.

Functionalities

New object classes

The main feature of apex is to provide classes for storing and handling multiple gene data. This is implemented through two novel formal (S4) classes, multidna and multiphyDat, which are respectively extensions of the DNAbin objects from the package ape (Paradis etal. 2004; Popescu etal. 2012), optimized for distance‐based methods, and phyDat objects from the package phangorn (Schliep 2011), better suited for parsimony and likelihood‐based approaches.

As in any formal class, the structure of multidna and multiphyDat is defined by a collection of predefined ‘slots’, each containing specific information such as the number of individuals in the data set, the various gene sequences and additional meta‐information. For the sake of simplicity, both classes have identical slots (Tables1 and 2) and only differ in the way genetic sequences are stored internally: multidna uses bytes to code nucleotides (DNAbin objects, Table1), while multiphyDat enumerates variable patterns in the sequences and can be used for DNA as well as amino acid sequences (phyDat objects, Table2). In both cases, aligned sequences are stored inside a list (Tables1 and 2), in which each element corresponds to a specific gene/locus. Besides storing genetic sequences, multidna and multiphyDat can also store labels for the individuals sequenced, as well as any metadata regarding the individuals or the genes of the data set (Tables1 and 2).

Table 1

Content of multidna objects. The content of each slot can be accessed using ‘@[slot name]’, where ‘[slot name]’ is any of the values listed in the first column

Slot nameData storedDescription
dnaalist of DNAbin matricesA list of DNAbin matrices, each storing sequences of a given locus/gene; names are optional, and if provided, identify the genes; all matrices have the same individuals in rows, and nucleotide positions in columns
labelscharacter vectorA vector of labels for the individuals
n.indintegerThe number of individuals in the data set
n.seqintegerThe total number of sequences, pooling all genes, and including gap‐only sequences
n.seq.missintegerThe total number of gap‐only sequences
ind.infoadata.frameA data.frame containing information on the individuals, where individuals are in rows
gene.infoadata.frameA data.frame containing information on the genes, where genes are in rows

Open in a separate window

aSlots whose content is NULL when empty.

Both classes ensure that data are stored in a consistent way. When creating new multidna or multiphyDat objects, all individuals with at least one sequence are first enumerated and sorted alphanumerically. For each locus, gap‐only sequences are created for every missing individual, and new alignments containing all individuals, sorted identically, are created. As a result, the different gene alignments and their analyses can be readily compared, which greatly facilitates the assessment of congruence amongst the loci.

Handling data

The fact that different gene data are stored in a consistent way also makes data manipulation easy. In both classes, we implemented matrix‐like subsetting using the syntax ‘[‘ operator. Assuming ‘x’ is a multidna or multiphyDat object, then ‘x[i, j]’ is a subset of ‘x’ where ‘i’ indicates the individuals to be kept, and ‘j’ the retained genes. This subsetting follows r standards and allows for vector of integers, characters or logical to be used, so that handling of multidna or multiphyDat objects should be as natural as usual objects (vectors and matrices).

In addition to the easy subsetting and reordering ofindividuals and genes, the generic function ‘concatenate’ can be used to merge several genes into a single alignment. By default, all genes in the object are used, but an optional argument permits to select which genes to include in the alignment.

Importing and exporting data

Building on resources provided in ape (Paradis etal. 2004; Popescu etal. 2012), phangorn (Schliep 2011) and adegenet (Jombart 2008; Jombart & Ahmed 2011), apex provides functions to import and export data from and to a variety of formats (Table2).

Table 2

Content of multiphyDat objects. The content of each slot can be accessed using ‘@[slot name]’, where ‘[slot name]’ is any of the values listed in the first column

Slot nameData storedDescription
seqalist of phyDat objectsA list of phyDat objects, each storing sequences of a given locus/gene; names are optional, and if provided identify the genes; all matrices have the same individuals in rows, and nucleotide positions in columns
typecharacter vectorA character string indicating the type of sequences (e.g. DNA, protein)
labelscharacter vectorA vector of labels for the individuals
n.indintegerThe number of individuals in the data set
n.seqintegerThe total number of sequences, pooling all genes, and including gap‐only sequences
n.seq.missintegerThe total number of gap‐only sequences
ind.infoadata.frameA data.frame containing information on the individuals, where individuals are in rows
gene.infoadata.frameA data.frame containing information on the genes, where genes are in rows

Open in a separate window

aSlots whose content is NULL when empty.

multidna and multiphyDat objects can both be created in r using the constructor ‘new(a, …)’, where ‘a’ is a character string indicating the class of the object (‘multidna’ or ‘multiphyDat’), and ‘’ is a list of arguments passed to the constructor, the main one being a list of objects (character, DNAbin or phyDat matrices) storing DNA or amino acid sequences. However, it is likely that in most cases, genetic sequences of different loci will be stored in separate text files, using one file per gene. Three functions permit to import data from a list of files directly into apex. The functions ‘read.multidna’ and ‘read.multiFASTA’ build upon ape's procedures to read data in interleaved, sequential, Clustal or FASTA format. In addition, the function ‘read.multiphyDat’ enables imports of amino acid sequences with interleaved, sequential or FASTA format. Note that in this case, the resulting multiphyDat object can no longer be converted to multidna, which is restricted to nucleotide sequences only.

Once imported in apex, data can also be converted to various formats (Table3). Conversion from multidna to multiphyDat is implemented by multidna2multiphyDat, while the reverse operation is performed by multiphyDat2multidna. Single‐nucleotide polymorphisms (SNPs) can be extracted from the alignments and translated into a genind object, thereby providing access to a wide range of multivariate analyses (Jombart etal. 2008, 2009, 2010b). As an alternative, each unique gene sequence can be treated as a separate allele, generalizing the multilocus sequence type (MLST) approach which proved highly useful for classifying clonal organisms in microbiology (Maiden etal. 1998; Aanensen & Spratt 2005; Maiden 2006), and could be equally useful for large gene collections of nonclonal organisms.

Accessors

A set of functions have been provided to access the slots in a multidna and multiphyDat objects. For example, the number of loci and their names can beobtained with the getNumLoci and getLocusNames functions, respectively. The setLocusNames function can also be used to set the names in the same way that the names, colnames and rownames functions work on standard r objects.

Table 3

Functions for importing and exporting data in apex

FunctionInputOutputNotes
read.multidnaInterleaved, sequential, clustal, fasta filesmultidnaBased on read.dna (ape package)
read.multiFASTAFasta filesmultidnaBased on read.FASTA (ape package)
read.multiphyDatInterleaved, fastamultiphyDatBased on read.phyDat (phangorn package) can read amino acid sequences
multidna2multiphyDatmultidnamultiphyDat
multiphyDat2multidnamultiphyDatmultidnaOnly works for DNA sequences
multidna2genindmultidnagenindaExtract either SNPs or haplotypes
multiphyDat2genindmultiphyDatgenindaExtract either SNPs or haplotypes

Open in a separate window

aBase class for genetic markers in the adegenet package.

The number of sequences at each locus stored in the@dna slot can be obtained with the getNumSequences function. Counts of number of sequences for specific loci can be produced by providing a vector of their names to the loci argument of this function. By default, only sequences not composed entirely of gaps are counted; however, if the exclude.gap.only argument is FALSE, the number of all sequences is returned. Names of sequences at each locus can be obtained with the getSequenceNames function, which also has the exclude.gap.only argument that functions similarly.

The sequences themselves can be returned with the getSequences function. By default, this returns the list of DNAbin‐formatted sequences stored in the @dna slot. The sequences can be filtered for specific individuals and loci by providing a character vector to the ids and loci arguments, respectively. If only a single locus is returned and the simplify argument is TRUE (the default), then the return value is a single DNAbin object. If simplify is FALSE, the function will always return a list of DNAbin objects.

Analysing data

As data visualization is often the first step in data analysis, we implemented a plot method for multidna objects, which permits to visualize the separate alignments simultaneously. This can be useful for a quick assessment of the quality of different alignments, or patterns of missing data (N or other ambiguous nucleotides) or alignment gaps. As each gene is an item of a list (the slots @dna and @seq, Tables1 and 2), any operation usually carried out on a single gene can be applied to all genes using the base r function lapply. However, to facilitate further the analysis of sequences from multiple genes, we provide functions for applying the most common phylogenetic analyses to multiple gene data. The 17 different genetic distances implemented in ape can be computed using multidna objects, either separately for each gene or after concatenating them, using dist.multidna. The function getTree provides a wrapper for a number of phylogenetic reconstruction methods implemented in ape, including different versions of neighbour‐joining (Saitou & Nei 1987; Gascuel 1997) and minimum evolution trees (Desper & Gascuel 2002).

Worked example

We illustrate a typical workflow of phylogenetic analysis in apex using data on eight species of New World chickadees (Aves: Paridae) typed on four nuclear loci (Harris etal. 2014). This data set is distributed with apex in two forms: a multidna object (data set ‘chickadees’) and as raw DNA alignments. We use the latter in this example. We assume all DNA alignments are stored as FASTA files in the working directory. After loading apex, we read and process the DNA alignments by selecting all files with ‘.fasta’ extension (this uses the base r command dir(pattern=".fasta")) using the apex function read.multiFASTA:

> library(apex)> x < - read.multiFASTA(dir(pattern=".fasta"))> x=== multidna ===[32 DNA sequences in 4 genes]@n.ind: 8 individuals@n.seq: 32 sequences in total@n.seq.miss: 8 gap-only (missing) sequences@labels: 2340_50156.ab1 2340_50149.ab12340_50674.ab1 ...@dna: (list of DNAbin matrices)...

Inspecting ‘x’, for example, by printing it (the full output, too long to be displayed, has been cut here) will indicate that the data consist of 32 DNA sequences coming from four different alignments which pooled together document 8 taxa. Eight gap‐only sequences were added by default for missing sequences, so that all DNAbin matrices in ‘x’ correspond to the same taxa (Fig.1). The actual number of taxa present in each alignment is as follows:

> getNumSequences(x)patr_poat43 patr_poat47 patr_poat48 patr_poat49 5 6 8 5 
Open in a separate window

Figure 1

Individual and concatenated sequence alignments of chickadees data. The first four graphs are a plot of a multidna object containing DNA alignments for four different loci (patr_poat 43, 47, 48 and 49). The fifth graph displays the concatenated alignment.

To ensure matching of taxa across genes, gap‐only sequences have been added where sequences were missing in ‘x’. For phylogenetic reconstruction, however, these gap sequences are best removed:

> x.nogaps <- read.multiFASTA(dir(pattern=".fasta"), gaps=FALSE)

Alignments can be visualized using the simple plot function (Fig.1). A concatenated alignment (Fig.1) can be obtained using the following:

> y < - concatenate(x)

Individual phylogenies can be obtained for each locus using the following:

> trees < - getTree(x.nogaps)

By default, getTree produces neighbour‐Joining trees using Hamming distances, using pairwise deletions, enforcing non‐negative branch lengths and ladderizing the trees. All of these can be customized using any distance and tree algorithms implemented in ape (Paradis etal. 2004), through arguments passed to getTree. Alternatively, a single tree can be obtained after concatenation of the alignments using the following:

> tree <- getTree(x, pool=TRUE)

Despite the modest size of this data set, results show substantial phylogenetic incongruence amongst different loci (Fig.2), stressing the need for considering several informative loci for achieving a more robust phylogenetic reconstruction (Harris etal. 2014).

Open in a separate window

Figure 2

Phylogenies of the chickadees data. The function getTree was used to obtain individual phylogenies for each locus (patr_poat43, 47, 48 and 49), and from the concatenated alignment (central phylogeny). Each phylogeny is an unrooted, neighbour‐joining tree based on Hamming distances between DNA sequences. Taxa are identified using colours to facilitate comparison of the trees.

Discussion

Phylogenetic analysis of multiple gene data can be a daunting task, requiring substantial prior data processing (e.g. comparing sequenced taxa across different loci, handling missing data) and replication and comparison of the analyses over all loci. So far, this could only be achieved in r using multiple ad hoc scripts (e.g. Bryson etal. 2013; Harris etal. 2013; Grummer etal. 2015), thereby limiting the reproducibility and reliability of the analyses, and discouraging the investigation of potential phylogenetic incongruence (Som 2015). The aim of apex is to streamline this process and make phylogenetic reconstruction with multiple genes as straightforward as with a single locus.

To achieve this goal, apex implements new object classes which extend existing standards for DNA and amino acid sequences. It provides simple functions for importing multiple alignments data from classical formats and software, seamlessly taking care of re‐ordering and matching taxa across loci, identifying missing sequences, and optionally adding gap‐only sequences to ensure matching of taxa for all loci. The resulting objects can be handled easily using various accessor functions, procedures for subsetting data by taxa, locus or site, and for concatenating selected loci. Additionally, apex implements a series of wrappers for the visualization and analysis of multiple gene data and implements a generalization of sequence‐type polymorphism (Maiden etal. 1998; Aanensen & Spratt 2005; Maiden 2006) directly compatible with standard population genetics methods (Goudet 2005; Jombart 2008; Paradis 2010; Jombart & Ahmed 2011). This latter feature should be particularly useful for deriving fast classifications of organisms (e.g. ‘sequence types’ in bacteria) from large genomic data sets.

Arguably, dedicated statistical approaches are needed for an in‐depth investigation of phylogenetic discrepancies exhibited by multilocus data (Hillis etal. 2005; Knowles 2009; Jombart etal. 2015; Som 2015). By providing support for the representation, visualization and basic analysis of these data, apex should facilitate and hopefully encourage the development of new methods for exploring phylogenetic incongruence. As such, we believe it is a worthwhile addition to the growing platform for genetic sequence analysis in r.

T.J., F.A., K.S. and Z.K. developed the package. R.H. provided data sets. J.G., E.P. and H.L. provided advice for the package design. T.J., F.A. and H.L. wrote the manuscript.

Software availability

The stable version of apex is released on the Comprehensive R Archive Network (CRAN):

http://cran.r-project.org/web/packages/apex/index.html

and can be installed in r by typing the following:

install.packages(apex)

The development version of apex is hosted on github:

https://github.com/thibautjombart/apex

apex is distributed under GNU Public Licence (GPL) version 2 or greater. It is fully documented in a vignette accessible by typing the following:

vignette(apex)

Acknowledgements

apex was first created at the Population Genetics in R Hackathon, which was held in March 2015 at the National Evolutionary Synthesis Center (NESCent) in Durham, NC, with the goal of addressing interoperability, scalability and workflow building challenges for the population genetics package ecosystem in r. The authors were participants in the hackathon and are indebted to NESCent (NSF #EF‐0905606) for hosting and supporting the event. TJ is funded by the Medical Research Council Centre for Outbreak Analysis and the National Institute for Health Research – Health Protection Research Unit (NIHR HPRU) in Modelling Methodology at Imperial College London in partnership with Public Health England (PHE). KS was supported in part by a grant from the National Science Foundation (DEB 1350474). ZK is supported by United States Department of Agriculture (USDA) Agricultural Research Service (ARS) grant 5358‐ 22000‐039‐00D, USDA Animal and Plant Health Inspection Service, the USDA‐ARS Floriculture Nursery Initiative, the Oregon Department of Agriculture/Oregon Association of Nurseries (ODA‐OAN) and the USDA Forest Service Forest Health Monitoring Program. This is publication ISEM 2016‐131. We are thankful to Github (http://github.com/), Travis (http://travis-ci.org/) and codecov (http://codecov.io) for providing great resources for software development. The views expressed are those of the author(s) and not necessarily those of the NHS, the NIHR, the Department of Health or Public Health England.

References

  • Aanensen DM, Spratt BG (2005) The multilocus sequence typing network: mlst.net. Nucleic Acids Research, 33, W728–W733. [PMC free article] [PubMed] [Google Scholar]
  • Bryson RW, Savary WE, Prendini L (2013) Biogeography of scorpions in the Pseudouroctonus minimus complex (Vaejovidae) from south‐western North America: implications of ecological specialization for pre‐Quaternary diversification. Journal of Biogeography, 40, 1850–1860. [Google Scholar]
  • Desper R, Gascuel O (2002) Fast and accurate phylogeny reconstruction algorithms based on the minimum‐evolution principle. Journal of Computational Biology, 9, 687–705. [PubMed] [Google Scholar]
  • Gascuel O (1997) BIONJ: an improved version of the NJ algorithm based on a simple model of sequence data. Molecular Biology and Evolution, 14, 685–695. [PubMed] [Google Scholar]
  • Goudet J (2005) hierfstat, a package for r to compute and test hierarchical F‐statistics. Molecular Ecology Notes, 5, 184–186. [Google Scholar]
  • Grummer JA, Calderon‐Espinosa ML, Nieto‐Montes de Oca A, Smith EN, Mendez‐de la Cruz FR, Leache AD (2015) Estimating the temporal and spatial extent of gene flow among sympatric high‐elevation lizard populations (genus Sceloporus) in southern Mexican highlands. Molecular Ecology, 24, 1523–1542. [PubMed] [Google Scholar]
  • Harris SR, Cartwright EJP, Török MEetal (2013) Whole‐genome sequencing for analysis of an outbreak of meticillin‐resistant Staphylococcus aureus: a descriptive study. The Lancet Infectious Diseases, 13, 130–136. [PMC free article] [PubMed] [Google Scholar]
  • Harris RB, Carling MD, Lovette IJ (2014) The influence of sampling design on species tree inference: a new relationship for the New World chickadees (Aves: Poecile). Evolution, 68, 501–513. [PubMed] [Google Scholar]
  • Hillis DM, Heath TA, St John K (2005) Analysis and visualization of tree space. Systematic Biology, 54, 471–482. [PubMed] [Google Scholar]
  • Jombart T (2008) adegenet: a R package for the multivariate analysis of genetic markers. Bioinformatics, 24, 1403–1405. [PubMed] [Google Scholar]
  • Jombart T, Ahmed I (2011) adegenet 1.3‐1: new tools for the analysis of genome‐wide SNP data. Bioinformatics, 27, 3070–3071. [PMC free article] [PubMed] [Google Scholar]
  • Jombart T, Devillard S, Dufour A‐B, Pontier D (2008) Revealing cryptic spatial patterns in genetic variability by a new multivariate method. Heredity, 101, 92–103. [PubMed] [Google Scholar]
  • Jombart T, Pontier D, Dufour A‐B (2009) Genetic markers in the playground of multivariate analysis. Heredity, 102, 330–341. [PubMed] [Google Scholar]
  • Jombart T, Balloux F, Dray S (2010a) adephylo: new tools for investigating the phylogenetic signal in biological traits. Bioinformatics, 26, 1907–1909. [PubMed] [Google Scholar]
  • Jombart T, Devillard S, Balloux F (2010b) Discriminant analysis of principal components: a new method for the analysis of genetically structured populations. BMC Genetics, 11, 94. [PMC free article] [PubMed] [Google Scholar]
  • Jombart T, Kendall M, Almagro‐Garcia J, Colijn C (2016) treescape: Statistical Exploration of Landscapes of Phylogenetic Trees. R package version 1.9.16. Available from http://CRAN.R-project.org/package=treescape. [PMC free article] [PubMed] [Google Scholar]
  • Kembel SW, Cowan PD, Helmus MRetal (2010) Picante: R tools for integrating phylogenies and ecology. Bioinformatics, 26, 1463–1464. [PubMed] [Google Scholar]
  • Knowles LL (2009) Estimating species trees: methods of phylogenetic analysis when there is incongruence across genes. Systematic Biology, 58, 463–467. [PubMed] [Google Scholar]
  • Maiden MCJ (2006) Multilocus sequence typing of bacteria. Annual Review of Microbiology, 60, 561–588. [PubMed] [Google Scholar]
  • Maiden MC, Bygraves JA, Feil Eetal (1998) Multilocus sequence typing: a portable approach to the identification of clones within populations of pathogenic microorganisms. Proceedings of the National Academy of Sciences of the United States of America, 95, 3140–3145. [PMC free article] [PubMed] [Google Scholar]
  • Paradis E (2010) pegas: an R package for population genetics with an integrated‐modular approach. Bioinformatics, 26, 419–420. [PubMed] [Google Scholar]
  • Paradis E, Claude J, Strimmer K (2004) APE: analyses of phylogenetics and evolution in R language. Bioinformatics, 20, 289–290. [PubMed] [Google Scholar]
  • Pareek CS, Smoczynski R, Tretyn A (2011) Sequencing technologies and genome sequencing. Journal of Applied Genetics, 52, 413–435. [PMC free article] [PubMed] [Google Scholar]
  • Pettersson E, Lundeberg J, Ahmadian A (2009) Generations of sequencing technologies. Genomics, 93, 105–111. [PubMed] [Google Scholar]
  • Pollard DA, Iyer VN, Moses AM, Eisen MB (2006) Widespread discordance of gene trees with species tree in Drosophila: evidence for incomplete lineage sorting. PLoS Genetics, 2, e173. [PMC free article] [PubMed] [Google Scholar]
  • Popescu A‐A, Huber KT, Paradis E (2012) ape 3.0: new tools for distance‐based phylogenetics and evolutionary analysis in R. Bioinformatics, 28, 1536–1537. [PubMed] [Google Scholar]
  • de Queiroz A, Gatesy J (2007) The supermatrix approach to systematics. Trends in Ecology & Evolution, 22, 34–41. [PubMed] [Google Scholar]
  • Rokas A, Williams BL, King N, Carroll SB (2003) Genome‐scale approaches to resolving incongruence in molecular phylogenies. Nature, 425, 798–804. [PubMed] [Google Scholar]
  • Saitou N, Nei M (1987) The neighbor‐joining method: a new method for reconstructing phylogenetic trees. Molecular Biology and Evolution, 4, 406–425. [PubMed] [Google Scholar]
  • Schliep KP (2011) phangorn: phylogenetic analysis in R. Bioinformatics, 27, 592–593. [PMC free article] [PubMed] [Google Scholar]
  • Som A (2015) Causes, consequences and solutions of phylogenetic incongruence. Briefings in Bioinformatics, 16, 536–548. [PubMed] [Google Scholar]
  • Weinert LA, Chaudhuri RR, Wang Jetal (2015) Genomic signatures of human and animal disease in the zoonotic pathogen Streptococcus suis. Nature Communications, 6, 6740. [PMC free article] [PubMed] [Google Scholar]
  • Wendel JF, Doyle JJ (1998) Phylogenetic incongruence: window into genome history and molecular evolution In: Molecular Systematics of Plants II(ed. Douglas ES, Pamela SS, Jeff JD.), pp. 265–296. Kluwer Academic Publisher, Norwell, Massachusetts. [Google Scholar]

Articles from Molecular Ecology Resources are provided here courtesy of Wiley-Blackwell, John Wiley & Sons

apex: phylogenetics with multiple genes (2024)
Top Articles
Latest Posts
Article information

Author: Ms. Lucile Johns

Last Updated:

Views: 6213

Rating: 4 / 5 (41 voted)

Reviews: 88% of readers found this page helpful

Author information

Name: Ms. Lucile Johns

Birthday: 1999-11-16

Address: Suite 237 56046 Walsh Coves, West Enid, VT 46557

Phone: +59115435987187

Job: Education Supervisor

Hobby: Genealogy, Stone skipping, Skydiving, Nordic skating, Couponing, Coloring, Gardening

Introduction: My name is Ms. Lucile Johns, I am a successful, friendly, friendly, homely, adventurous, handsome, delightful person who loves writing and wants to share my knowledge and understanding with you.