Chapter 4 Phylogenetic Tree Visualization
4.1 Introduction
There are many software packages and webtools that are designed for displaying phylogenetic trees, such as TreeView (Page 2002), FigTree10, TreeDyn (Chevenet et al. 2006), Dendroscope (Huson and Scornavacca 2012), EvolView (He et al. 2016) and iTOL (Letunic and Bork 2007), etc.. Only several of them, such as FigTree, TreeDyn and iTOL, allow users to annotate the trees with coloring branches, highlighted clades with tree features. However, their pre-defined annotating functions are usually limited to some specific phylogenetic data. As phylogenetic trees are becoming more widely used in multidisciplinary studies, there is an increasing need to incorporate various types of the phylogenetic covariates and other associated data from different sources into the trees for visualizations and further analyses. For instance, influenza virus has a wide host range, diverse and dynamic genotypes and characteristic transmission behaviors that are mostly associated with the virus evolution and essentially among themselves. Therefore, in addition to standalone applications that focus on each of the specific analysis and data type, researchers studying molecular evolution need a robust and programmable platform that allows the high levels of integration and visualization of many of these different aspects of data (raw or from other primary analyses) over the phylogenetic trees to identify their associations and patterns.
To fill this gap, we developed ggtree, a package for the R programming language (R Core Team 2016) released under the Bioconductor project (Gentleman et al. 2004). The ggtree is built to work with phylogenetic data object (see chapter 1 and chapter 9), and display tree graphics with ggplot2 package (Wickham 2016) that was based on the grammar of graphics (Wilkinson et al. 2005).
The R language is increasingly being used in phylogenetics. However, a comprehensive package, designed for viewing and annotating phylogenetic trees, particularly with complex data integration, is not yet available. Most of the R packages in phylogenetics focus on specific statistical analyses rather than viewing and annotating the trees with more generalized phylogeny-associated data. Some packages, including ape (Paradis, Claude, and Strimmer 2004) and phytools (Revell 2012), which are capable of displaying and annotating trees, are developed using the base graphics system of R. In particular, ape is one of the fundamental package for phylogenetic analysis and data processing. However, the base graphics system is relatively difficult to extend and limits the complexity of tree figure to be displayed. OutbreakTools (Jombart et al. 2014) and phyloseq (McMurdie and Holmes 2013) extended ggplot2 to plot phylogenetic trees. The ggplot2 system of graphics allows rapid customization and exploration of design solutions. However these packages were designed for epidemiology and microbiome data respectively and did not aim to provide a general solution for tree visualization and annotation. The ggtree package also inherits versatile properties of ggplot2, and more importantly allows constructing complex tree figures by freely combining multiple layers of annotations using the tree associated data imported from different sources (see detailed in Chapter 1).
4.2 Visualizing Phylogenetic Tree with ggtree
The ggtree package is designed for annotating phylogenetic trees with their associated data of different types and from various sources. These data could come from users or analysis programs, and might include evolutionary rates, ancestral sequences, etc. that are associated with the taxa from real samples, or with the internal nodes representing hypothetic ancestor strain/species, or with the tree branches indicating evolutionary time courses. For instance, the data could be the geographic positions of the sampled avian influenza viruses (informed by the survey locations) and the ancestral nodes (by phylogeographic inference) in the viral gene tree (Lam et al. 2012).
The ggtree supports ggplot2âs graphical language, which allows high level of customization, is intuitive and flexible. It is notable that ggplot2 itself does not provide low-level geometric objects or other support for tree-like structures, and hence ggtree is a useful extension on that regard. Even though the other two phylogenetics-related R packages, OutbreakTools and phyloseq, are developed based on ggplot2, the most valuable part of ggplot2 syntax - adding layers of annotations - is not supported in these packages. For example, if we have plotted a tree without taxa labels, OutbreakTools and phyloseq provide no easy way for general R
users, who have little knowledge about the infrastructures of these packages, to add a layer of taxa labels. The ggtree extends ggplot2 to support tree objects by implementing a geometric layer, geom_tree
, to support visualizing tree structure. In ggtree, viewing a phylogenetic tree is relatively easy, via the command ggplot(tree_object) + geom_tree() + theme_tree()
or ggtree(tree_object)
for short. Layers of annotations can be added one by one via the +
operator. To facilitate tree visualization, ggtree provides several geometric layers, including geom_treescale
for adding legend of tree branch scale (genetic distance, divergence time, etc.), geom_range
for displaying uncertainty of branch lengths (confidence interval or range, etc.), geom_tiplab
for adding taxa label, geom_tippoint
and geom_nodepoint
for adding symbols of tips and internal nodes, geom_hilight
for highlighting a clade with rectangle, and geom_cladelabel
for annotating a selected clade with a bar and text label, etc.. A full list of geometric layers provided by ggtree are summarized in Table 5.1.
To view a phylogenetic tree, we first need to parse the tree file into R
.
Treeio package parses diverse annotation data from different software outputs into S4
phylogenetic data objects. The ggtree mainly utilizes these S4
objects to display and annotate the tree. There are also other R packages that defined S3
/S4
classes to store phylogenetic trees with domain specific associated data, including phylo4
and phylo4d
defined in phylobase package, obkdata
defined in OutbreakTools package, and phyloseq
defined in phyloseq package (see also Chapter 9). All these tree objects are also supported in ggtree and their specific annotation data can be used to annotate the tree in ggtree. Such compatibility of ggtree facilitates the integration of data and analysis results. In addition, ggtree also supports other tree-like structure, including dendrogram.
4.2.1 Basic Tree Visualization
The ggtree package extends ggplot2 (Wickham 2009) package to support viewing phylogenetic tree.
It implements geom_tree
layer for displaying phylogenetic tree, as shown below in Figure 4.1A.
library("treeio")
library("ggtree")
system.file("extdata", "sample.nwk", package="treeio")
nwk <- read.tree(nwk)
tree <-
ggplot(tree, aes(x, y)) + geom_tree() + theme_tree()
The function, ggtree
, was implemented as a short cut to visualize a tree, and it works exactly the same as shown above.
ggtree takes all the advantages of ggplot2. For example, we can change the color, size and type of the lines as we do with ggplot2 (Figure 4.1B).
ggtree(tree, color="firebrick", size=2, linetype="dotted")
By default, the tree is viewed in ladderize form, user can set the parameter ladderize = FALSE
to disable it (Figure 4.1C).
ggtree(tree, ladderize=FALSE)
The branch.length
is used to scale the edge, user can set the parameter branch.length = "none"
to only view the tree topology (cladogram, Figure 4.1D) or other numerical variable to scale the tree (e.g. dN/dS, see also in Chapter 5).
ggtree(tree, branch.length="none")
4.2.2 Layouts of phylogenetic tree
Viewing phylogenetic with ggtree is quite simple, just pass the tree object to ggtree function. We have developed several types of layouts for tree presentation (Figure 4.2), including rectangular (by default), slanted, circular, fan, unrooted (equal angle and daylight methods), time-scaled and 2-dimensional layouts.
Here are examples of visualizing a tree with different layouts:
library(ggtree)
set.seed(2017-02-16)
rtree(50)
tree <-ggtree(tree)
ggtree(tree, layout="slanted")
ggtree(tree, layout="circular")
ggtree(tree, layout="fan", open.angle=120)
ggtree(tree, layout="equal_angle")
ggtree(tree, layout="daylight")
ggtree(tree, branch.length='none')
ggtree(tree, branch.length='none', layout='circular')
ggtree(tree, layout="daylight", branch.length = 'none')
There are also other possible layouts that can be drawn by modifying scales/coordination (Figure 4.3).
ggtree(tree) + scale_x_reverse()
ggtree(tree) + coord_flip()
ggtree(tree) + layout_dendrogram()
print(ggtree(tree), newpage=TRUE, vp=grid::viewport(angle=-30, width=.9, height=.9))
ggtree(tree, layout='slanted') + coord_flip()
ggtree(tree, layout='slanted', branch.length='none') + layout_dendrogram()
ggtree(tree, layout='circular') + xlim(-10, NA)
ggtree(tree) + scale_x_reverse() + coord_polar(theta='y')
ggtree(tree) + scale_x_reverse(limits=c(10, 0)) + coord_polar(theta='y')
Phylogram. Layouts of rectangular, slanted, circular and fan are supported to visualize phylogram (by default, with branch length scaled) as demonstrated in Figure 4.2A, B, C and D.
Unrooted layout. Unrooted (also called âradialâ) layout is supported by equal-angle and daylight algorithms, user can specify unrooted layout algorithm by passing âequal_angleâ or âdaylightâ to layout
parameter to visualize the tree. Equal-angle method was proposed by Christopher Meacham in PLOTREE, which was incorporated in PHYLIP (Retief 2000). This method starts from the root of the tree and allocates arcs of angle to each subtrees proportional to the number of tips in it. It iterates from root to tips and subdivides the angle allocated to a subtree into angles for its dependent subtrees. This method is fast and was implemented in many software packages. As shown in Figure 4.2E, equal angle method has a drawback that tips are tend to be clustered together and leaving many spaces unused. The daylight method starts from an initial tree built by equal angle and iteratively improves it by successively going to each interior node and swinging subtrees so that the arcs of âdaylightâ are equal (Figure 4.2F). This method was firstly implemented in PAUP* (Wilgenbusch and Swofford 2003).
Cladogram. To visualize cladogram that without branch length scaling and only display the tree structure, branch.length
is set to ânoneâ and it works for all types of layouts (Figure 4.2G, H and I).
Time-scaled layout. For time-scaled tree, the most recent sampling date must be specified via the mrsd
parameter and ggtree will scaled the tree by sampling (tip) and divergence (internal node) time, and a time scale axis will be displayed under the tree by default.
system.file("examples/MCC_FluA_H3.tree",
beast_file <-package="ggtree")
read.beast(beast_file)
beast_tree <-ggtree(beast_tree, mrsd="2013-01-01") + theme_tree2()
Two-dimensional tree layout. A two-dimensional tree is a projection of the phylogenetic tree in a space defined by the associated phenotype (numerical or categorical trait, on the y-axis) and tree branch scale (e.g., evolutionary distance, divergent time, on the x-axis). The phenotype can be a measure of certain biological characteristics of the taxa and hypothetical ancestors in the tree. This is a new layout we proposed in ggtree, which is useful to track the virus phenotypes or other behaviors (y-axis) changing with the virus evolution (x-axis). In fact, the analysis of phenotypes or genotypes over evolutionary time have been widely used for study influenza virus evolution (Neher et al. 2016), though such analysis diagrams are not tree-like, i.e., no connection between data points, unlike our two-dimensional tree layout that connect data points with the corresponding tree branches. Therefore, this new layout we provided will make such data analysis easier and more scalable for large sequence data sets of influenza viruses.
In this example, we used the previous time-scaled tree of H3 human and swine influenza viruses (Figure 4.4; data published in (Liang et al. 2014)) and scaled the y-axis based on the predicted N-linked glycosylation sites (NLG) for each of the taxon and ancestral sequences of hemagglutinin proteins. The NLG sites were predicted using NetNGlyc 1.0 Server11. To scaled the y-axis, the parameter yscale
in the ggtree()
function is set to a numerical or categorical variable. If yscale
is a categorical variable as in this example, users should specify how the categories are to be mapped to numerical values via the yscale_mapping
variables.
system.file("examples/NAG_inHA1.txt", package="ggtree")
NAG_file <-
read.table(NAG_file, sep="\t", header=FALSE,
NAG.df <-stringsAsFactors = FALSE)
NAG.df[,2]
NAG <-names(NAG) <- NAG.df[,1]
## separate the tree by host species
get.tree(beast_tree)$tip.label
tip <- groupOTU(beast_tree, tip[grep("Swine", tip)],
beast_tree <-group_name = "host")
ggtree(beast_tree, aes(color=host), mrsd="2013-01-01",
p <-yscale = "label", yscale_mapping = NAG) +
theme_classic() + theme(legend.position='none') +
scale_color_manual(values=c("blue", "red"),
labels=c("human", "swine")) +
ylab("Number of predicted N-linked glycoslyation sites")
## (optional) add more annotations to help interpretation
+ geom_nodepoint(color="grey", size=3, alpha=.8) +
p geom_rootpoint(color="black", size=3) +
geom_tippoint(size=3, alpha=.5) +
annotate("point", 1992, 5.6, size=3, color="black") +
annotate("point", 1992, 5.4, size=3, color="grey") +
annotate("point", 1991.6, 5.2, size=3, color="blue") +
annotate("point", 1992, 5.2, size=3, color="red") +
annotate("text", 1992.3, 5.6, hjust=0, size=4, label="Root node") +
annotate("text", 1992.3, 5.4, hjust=0, size=4,
label="Internal nodes") +
annotate("text", 1992.3, 5.2, hjust=0, size=4,
label="Tip nodes (blue: human; red: swine)")
As shown in Figure 4.5, two-dimensional tree good at visualizing the change of phenotype over the evolution in the phylogenetic tree. In this example, it is shown that H3 gene of human influenza A virus maintained high level of N-linked glycosylation sites (n=8 to 9) over last two decades and dropped significantly to 5 or 6 in a separate viral lineage transmitted to swine populations and established there. It was indeed hypothesized that the human influenza virus with high level of glycosylation on the viral hemagglutinin protein provides better shielding effect to protect the antigenic sites from exposure to the herd immunity, and thus has selective advantage in human populations that maintain high level of herd immunity against the circulating human influenza virus strains. For the viral lineage that newly jumped across the species barrier and transmitted to swine population, the shielding effect of the high-level surface glycan oppositely impose selective disadvantage because the receptor-binding domain may also be shielded which greatly affect the viral fitness of the lineage that newly adapted to a new host species. Another example of two-dimensional tree can be found on Figure 4.12.
4.3 Displaying Tree Components
4.3.1 Displaying tree scale (evolution distance)
To show tree scale, user can use geom_treescale()
layer (Figure 4.6A).
ggtree(tree) + geom_treescale()
geom_treescale()
supports the following parameters:
- x and y for tree scale position
- width for the length of the tree scale
- fontsize for the size of the text
- linesize for the size of the line
- offset for relative position of the line and the text
- color for color of the tree scale
ggtree(tree) + geom_treescale(x=0, y=45, width=1, color='red')
ggtree(tree) + geom_treescale(fontsize=6, linesize=2, offset=1)
We can also use theme_tree2()
to display the tree scale by adding x axis.
ggtree(tree) + theme_tree2()
Tree scale is not restricted to evolution distance, treeio can re-scale the tree with other numerical variable (details described in session 2.3).
4.3.2 Displaying nodes/tips
Showing all the internal nodes and tips in the tree can be done by adding a layer of points using geom_nodepoint
, geom_tippoint
or geom_point
.
ggtree(tree) + geom_point(aes(shape=isTip, color=isTip), size=3)
ggtree(tree) + geom_nodepoint(color="#b5e521", alpha=1/4, size=10)
p <-+ geom_tippoint(color="#FDAC4F", shape=8, size=3) p
4.3.3 Displaying labels
Users can use geom_text
or geom_label
to display the node (if available) and tip labels simultaneously or geom_tiplab
to only display tip labels (Figure 4.8A).
+ geom_tiplab(size=3, color="purple") p
geom_tiplab
not only supports using text or label geom to display labels,
it also supports image geom to label tip with image files (see Chapter 7). A corresponding
geom, geom_nodelab
is also provided for displaying node labels.
For circular and unrooted layout, ggtree supports rotating node labels according to the angles of the branches (Figure 4.8B).
ggtree(tree, layout="circular") + geom_tiplab(aes(angle=angle), color='blue')
For long tip labels, the label maybe truncated. There are several ways to solve this issue (see FAQ: Tip label truncated).
Another solution to solve this issue is to display tip labels as y-axis labels (Figure 4.8C). However it only works for rectangular and dendrogram layouts and users need to use theme()
to adjust tip labels in this case.
ggtree(tree) + geom_tiplab(as_ylab=TRUE, color='firebrick')
By default, the positions to display text are based on the node positions, we can change them to based on the middle of the branch/edge (by setting aes(x = branch)
), which is very useful when annotating transition from parent node to child node.
4.3.4 Displaying root edge
ggtree doesnât plot root edge by default. Users can use geom_rootedge()
to automatically display root edge (Figure 4.9A). If there is no root edge information, geom_rootedge()
will display nothing by default (Figure 4.9B). Users can set the root edge to the tree (Figure 4.9C) or specify rootedge
in geom_rootedge()
(Figure 4.9D).
## with root edge = 1
read.tree(text='((A:1,B:2):3,C:2):1;')
tree1 <-ggtree(tree1) + geom_tiplab() + geom_rootedge()
## without root edge
read.tree(text='((A:1,B:2):3,C:2);')
tree2 <-ggtree(tree2) + geom_tiplab() + geom_rootedge()
## setting root edge
$root.edge <- 2
tree2ggtree(tree2) + geom_tiplab() + geom_rootedge()
## specify length of root edge for just plotting
## this will ignore tree$root.edge
ggtree(tree2) + geom_tiplab() + geom_rootedge(rootedge = 3)
4.3.5 Color tree
In ggtree
, coloring phylogenetic tree is easy, by using aes(color=VAR)
to map the color of tree based on a specific variable (numeric and category are both supported).
ggtree(beast_tree, aes(color=rate)) +
scale_color_continuous(low='darkgreen', high='red') +
theme(legend.position="right")
User can use any feature (if available), including clade posterior and dN/dS etc., to scale the color of the tree. If the feature is continuous numerical value, ggtree provides a continuous
parameter to support plotting continuous state transition in edges. Here, we use the example provided in http://www.phytools.org/eqg2015/asr.html to demonstrate this functionality. If you want to add a thin black border in tree branches, you can place a tree with black and slightly thicker branches below your tree to emulate edge outlines as demonstrated in Figure 4.11B.
read.tree("http://www.phytools.org/eqg2015/data/anole.tre")
anole.tree<- read.csv("http://www.phytools.org/eqg2015/data/svl.csv",
svl <-row.names=1)
as.matrix(svl)[,1]
svl <- phytools::fastAnc(anole.tree,svl,vars=TRUE,CI=TRUE)
fit <-
data.frame(node = nodeid(anole.tree, names(svl)),
td <-trait = svl)
data.frame(node = names(fit$ace), trait = fit$ace)
nd <-
rbind(td, nd)
d <-$node <- as.numeric(d$node)
d full_join(anole.tree, d, by = 'node')
tree <-
ggtree(tree, aes(color=trait), layout = 'circular',
p1 <-ladderize = FALSE, continuous = TRUE, size=2) +
scale_color_gradientn(colours=c("red", 'orange', 'green', 'cyan', 'blue')) +
geom_tiplab(hjust = -.1) +
xlim(0, 1.2) +
theme(legend.position = c(.05, .85))
ggtree(tree, layout='circular', ladderize = FALSE, size=2.8) +
p2 <- geom_tree(aes(color=trait), continuous=T, size=2) +
scale_color_gradientn(colours=c("red", 'orange', 'green', 'cyan', 'blue')) +
geom_tiplab(aes(color=trait), hjust = -.1) +
xlim(0, 1.2) +
theme(legend.position = c(.05, .85))
::plot_grid(p1, p2, ncol=2, labels=c("A", "B")) cowplot
Besides, we can use two-dimensional tree (as demonstrated in Figure 4.5) to visualize phenotype on the vertical dimension to create the phenogram. We can use ggrepel package to repel tip labels to avoid overlapping as demonstrated in Figure A.4.
ggtree(tree, aes(color=trait), continuous = TRUE, yscale = "trait") +
scale_color_viridis_c() + theme_minimal()
4.3.6 Rescale tree
Most of the phylogenetic trees are scaled by evolutionary distance (substitution/site). In ggtree
, users can re-scale a phylogenetic tree by any numerical variable inferred by evolutionary analysis (e.g. dN/dS).
This example displays a time tree (Figure 4.13A) and the branches were rescaled by substitution rate inferred by BEAST (Figure 4.13B).
library("treeio")
system.file("examples/MCC_FluA_H3.tree", package="ggtree")
beast_file <- read.beast(beast_file)
beast_tree <- beast_tree
## 'treedata' S4 object that stored information of
## '/home/ygc/R/library/ggtree/examples/MCC_FluA_H3.tree'.
##
## ...@ phylo:
## Phylogenetic tree with 76 tips and 75 internal nodes.
##
## Tip labels:
## A/Hokkaido/30-1-a/2013, A/New_York/334/2004, A/New_York/463/2005, A/New_York/452/1999, A/New_York/238/2005, A/New_York/523/1998, ...
##
## Rooted; includes branch lengths.
##
## with the following features available:
## 'height', 'height_0.95_HPD', 'height_median',
## 'height_range', 'length', 'length_0.95_HPD',
## 'length_median', 'length_range', 'posterior', 'rate',
## 'rate_0.95_HPD', 'rate_median', 'rate_range'.
ggtree(beast_tree, mrsd='2013-01-01') + theme_tree2() +
p1 <- labs(caption="Divergence time")
ggtree(beast_tree, branch.length='rate') + theme_tree2() +
p2 <- labs(caption="Substitution rate")
The following example draw a tree inferred by CodeML (Figure 4.13C), and the branches can be rescaled by using dN/dS values (Figure 4.13D).
system.file("extdata/PAML_Codeml", "mlc", package="treeio")
mlcfile <- read.codeml_mlc(mlcfile)
mlc_tree <- ggtree(mlc_tree) + theme_tree2() +
p3 <- labs(caption="nucleotide substitutions per codon")
ggtree(mlc_tree, branch.length='dN_vs_dS') + theme_tree2() +
p4 <- labs(caption="dN/dS tree")
In addition to specify branch.length
in tree visualization, users can change branch length stored in tree object by using rescale_tree
function, and the following command will display a tree that is identical to (Figure 4.13B).
rescale_tree(beast_tree, branch.length='rate')
beast_tree2 <-ggtree(beast_tree2) + theme_tree2()
4.3.7 Modify compenents of a theme
theme_tree()
defined a totally blank canvas, while theme_tree2()
adds
phylogenetic distance (via x-axis). These two themes all accept a parameter of
bgcolor
that defined the background color. Users can use any theme components to the theme_tree()
or theme_tree2()
functions to modify them.
set.seed(2019)
rtree(30)
x <-ggtree(x, color="red") + theme_tree("steelblue")
ggtree(x, color="white") + theme_tree("black")
Users can also use image file as tree background, see example in Appendix B.
4.4 Visualize a list of trees
ggtree
supports multiPhylo
object and a list of trees can be viewed simultaneously.
## trees <- lapply(c(10, 20, 40), rtree)
## class(trees) <- "multiPhylo"
## ggtree(trees) + facet_wrap(~.id, scale="free") + geom_tiplab()
read.r8s(system.file("extdata/r8s", "H3_r8s_output.log", package="treeio"))
r8s <-ggtree(r8s) + facet_wrap( ~.id, scale="free") + theme_tree2()
One hundred bootstrap trees can also be view simultaneously.
read.tree(system.file("extdata/RAxML", "RAxML_bootstrap.H3", package="treeio"))
btrees <-ggtree(btrees) + facet_wrap(~.id, ncol=10)
Another way to view the bootstrap trees is to merge them together to form a density tree using ggdensitree
function.
ggdensitree(btrees, alpha=.3, colour='steelblue') +
geom_tiplab(size=3) + xlim(0, 45)
4.5 Summary
Visualizing phylogenetic tree using ggtree is easy by using a single command ggtree(tree)
. The ggtree package provides several geometric layers to display tree components such as tip labels, symbolic points for both external and internal nodes, root edge, etc. Associated data can be used to rescale branch lengths, color the tree and display on the tree. All these can be done by the ggplot2 grammar of graphic syntax. ggtree also provides several layers that are specifically designed for tree annotation (see Chapter 5).
References
Chevenet, François, Christine Brun, Anne-Laure Bañuls, Bernard Jacq, and Richard Christen. 2006. âTreeDyn: Towards Dynamic Graphics and Annotations for Analyses of Trees.â BMC Bioinformatics 7 (October): 439. https://doi.org/10.1186/1471-2105-7-439.
Gentleman, Robert C, Vincent J Carey, Douglas M Bates, Ben Bolstad, Marcel Dettling, Sandrine Dudoit, Byron Ellis, et al. 2004. âBioconductor: Open Software Development for Computational Biology and Bioinformatics.â Genome Biology 5 (10): R80. https://doi.org/10.1186/gb-2004-5-10-r80.
He, Zilong, Huangkai Zhang, Shenghan Gao, Martin J. Lercher, Wei-Hua Chen, and Songnian Hu. 2016. âEvolview V2: An Online Visualization and Management Tool for Customized and Annotated Phylogenetic Trees.â Nucleic Acids Research 44 (W1): W236â241. https://doi.org/10.1093/nar/gkw370.
Huson, Daniel H., and Celine Scornavacca. 2012. âDendroscope 3: An Interactive Tool for Rooted Phylogenetic Trees and Networks.â Systematic Biology 61 (6): 1061â7. https://doi.org/10.1093/sysbio/sys062.
Jombart, Thibaut, David M. Aanensen, Marc Baguelin, Paul Birrell, Simon Cauchemez, Anton Camacho, Caroline Colijn, et al. 2014. âOutbreakTools: A New Platform for Disease Outbreak Analysis Using the R Software.â Epidemics 7 (June): 28â34. https://doi.org/10.1016/j.epidem.2014.04.003.
Lam, Tommy Tsan-Yuk, Chung-Chau Hon, Philippe Lemey, Oliver G. Pybus, Mang Shi, Hein Min Tun, Jun Li, Jingwei Jiang, Edward C. Holmes, and Frederick Chi-Ching Leung. 2012. âPhylodynamics of H5N1 Avian Influenza Virus in Indonesia.â Molecular Ecology 21 (12): 3062â77. https://doi.org/10.1111/j.1365-294X.2012.05577.x.
Letunic, Ivica, and Peer Bork. 2007. âInteractive Tree of Life (iTOL): An Online Tool for Phylogenetic Tree Display and Annotation.â Bioinformatics 23 (1): 127â28. https://doi.org/10.1093/bioinformatics/btl529.
Liang, Huyi, Tommy Tsan-Yuk Lam, Xiaohui Fan, Xinchun Chen, Yu Zeng, Ji Zhou, Lian Duan, et al. 2014. âExpansion of Genotypic Diversity and Establishment of 2009 H1N1 Pandemic-Origin Internal Genes in Pigs in China.â Journal of Virology, July, JVI.01327â14. https://doi.org/10.1128/JVI.01327-14.
McMurdie, Paul J., and Susan Holmes. 2013. âPhyloseq: An R Package for Reproducible Interactive Analysis and Graphics of Microbiome Census Data.â PLoS ONE 8 (4): e61217. https://doi.org/10.1371/journal.pone.0061217.
Neher, Richard A., Trevor Bedford, Rodney S. Daniels, Colin A. Russell, and Boris I. Shraiman. 2016. âPrediction, Dynamics, and Visualization of Antigenic Phenotypes of Seasonal Influenza Viruses.â Proceedings of the National Academy of Sciences 113 (12): E1701âE1709. https://doi.org/10.1073/pnas.1525578113.
Page, Roderic D. M. 2002. âVisualizing Phylogenetic Trees Using TreeView.â Current Protocols in Bioinformatics Chapter 6 (August): Unit 6.2. https://doi.org/10.1002/0471250953.bi0602s01.
Paradis, Emmanuel, Julien Claude, and Korbinian Strimmer. 2004. âAPE: Analyses of Phylogenetics and Evolution in R Language.â Bioinformatics 20 (2): 289â90. https://doi.org/10.1093/bioinformatics/btg412.
R Core Team. 2016. R: A Language and Environment for Statistical Computing. Vienna, Austria: R Foundation for Statistical Computing. https://www.R-project.org/.
Retief, J. D. 2000. âPhylogenetic Analysis Using PHYLIP.â Methods in Molecular Biology (Clifton, N.J.) 132: 243â58.
Revell, Liam J. 2012. âPhytools: An R Package for Phylogenetic Comparative Biology (and Other Things).â Methods in Ecology and Evolution 3 (2): 217â23. https://doi.org/10.1111/j.2041-210X.2011.00169.x.
Wickham, Hadley. 2009. Ggplot2: Elegant Graphics for Data Analysis. 1st ed. Springer.
Wickham, Hadley. 2016. Ggplot2: Elegant Graphics for Data Analysis. Springer. http://ggplot2.org.
Wilgenbusch, James C., and David Swofford. 2003. âInferring Evolutionary Trees with PAUP*.â Current Protocols in Bioinformatics Chapter 6 (February): Unit 6.4. https://doi.org/10.1002/0471250953.bi0604s00.
Wilkinson, Leland, D. Wills, D. Rope, A. Norton, and R. Dubbs. 2005. The Grammar of Graphics. 2nd edition. New York: Springer.