Skip to main content

Automated analysis of phylogenetic clusters

Abstract

Background

As sequence data sets used for the investigation of pathogen transmission patterns increase in size, automated tools and standardized methods for cluster analysis have become necessary. We have developed an automated Cluster Picker which identifies monophyletic clades meeting user-input criteria for bootstrap support and maximum genetic distance within large phylogenetic trees. A second tool, the Cluster Matcher, automates the process of linking genetic data to epidemiological or clinical data, and matches clusters between runs of the Cluster Picker.

Results

We explore the effect of different bootstrap and genetic distance thresholds on clusters identified in a data set of publicly available HIV sequences, and compare these results to those of a previously published tool for cluster identification. To demonstrate their utility, we then use the Cluster Picker and Cluster Matcher together to investigate how clusters in the data set changed over time. We find that clusters containing sequences from more than one UK location at the first time point (multiple origin) were significantly more likely to grow than those representing only a single location.

Conclusions

The Cluster Picker and Cluster Matcher can rapidly process phylogenetic trees containing tens of thousands of sequences. Together these tools will facilitate comparisons of pathogen transmission dynamics between studies and countries.

Background

In order to control the spread of disease and optimize public health interventions, it is crucial to understand how transmission from one individual to the next occurs. Identifying at risk individuals and behaviors through contact tracing has been a successful strategy in controlling many infectious diseases. Recently, the rise of sequencing and other technologies have meant that disease transmission can be studied at the molecular level. One example of molecular epidemiology is the reconstruction of transmission trees based on the genetic relatedness of pathogens, which reflect the relationships between infected individuals [1].

With their fast evolving genomes [2], RNA viruses are particularly well suited to phylogenetic analyses, and studies have been carried out extensively on HIV [1, 3, 4], as well as on hepatitis C [5], Ebola [6], severe acute respiratory syndrome (SARS) [7] and dengue [8]. Despite their lower genetic diversity, phylogenetic analyses are increasingly being used to investigate the transmission of DNA viruses such as herpes and even of bacteria [9, 10].

Due to the uncertainty in infection time, evolutionary rate and potential contacts, it is generally not possible to reconstruct the exact transmission network from a phylogenetic tree alone. However patients sharing similar viruses are potentially epidemiologically linked, so local outbreaks within the larger epidemic can be identified by finding transmission clusters. Clusters in epidemiology are broadly described as an unusual aggregation of infection, perceived to be greater than that expected by chance. In networks, clusters are quantitatively defined as a group of nodes having a local clustering coefficient significantly greater than that of a random graph with the same number of vertices and the same mean shortest path [11]. In a phylogenetic tree, clusters contain sequences from different patients which share a recent common ancestor. These clusters are manifest as groupings in the phylogenetic tree in which we have high confidence and which are likely to reflect recent or ongoing transmission. However, defining and detecting meaningful transmission clusters from a population sample in a phylogenetic tree is not straightforward, and various strategies have been proposed and used in the literature.

Clusters are often defined based on high support (bootstrap or posterior probability) and/or low within cluster genetic distance, but the thresholds for both vary. For HIV, bootstraps ranging from 70% and up to 99% have been used [5, 12-16], in combination with within-cluster genetic distances from 1% to 4.5% substitutions per site [3, 13-15, 17, 18]. The method for calculating within cluster genetic distance also varies: the mean of the pairwise genetic distances of clustered sequences has been employed [16], as well as their median [19]. Another alternative is “single linkage”, where a sequence is included in a cluster if its distance to just one other sequence in the cluster is below the threshold [20, 21]. If time resolved trees are used (which require knowledge or inference of a molecular clock), clusters can be defined based on time to most recent common ancestor [22]. These most resemble clusters generated using maximum genetic distance in a non-time resolved distance-based tree.

In the case of HIV, analyses of phylogenetic clusters have been used to identify correlates of transmission including risk group [18], stage of infection [23, 24], cluster size [25], the presence or absence of co-infections, including other sexually transmitted infections [13] as well as drug treatment and compliance. A recent study used a phylogenetic approach to determine the relative contribution of each of these variables to the risk of onward transmission [26], finding that antiretroviral treatment decreased HIV transmission risk.

With sequence data sets used for the reconstruction of phylogenies now containing tens of thousands of sequences, identifying clusters manually is infeasible. Using in-house pipe lines for detecting clusters is possible, but in order to compare results between studies, freely available software tools would be advantageous. Based on the support and genetic distance criteria commonly used, we have developed the Cluster Picker (CP) which identifies clusters in phylogenetic trees. Furthermore, we introduce the Cluster Matcher (CM), the first tool to describe identified clusters epidemiologically as well match clusters between phylogenetic trees. To demonstrate their utility, we use both these tools to examine subtype B cluster dynamics in the UK and we compare CP performance to that of other available software.

Implementation

The Cluster Picker and Cluster Matcher have been developed in Java 1.6 and are platform-independent. Both programs can be downloaded freely from http://hiv.bio.ed.ac.uk/software.html as functioning jar files with accompanying tutorials, manuals and test files. Source code is available on Google code (http://code.google.com/p/cluster-picker-and-cluster-matcher/) under GNU GPLv3.

The Cluster Picker

Objective

The CP is a JAVA based program that identifies clusters of sequences in a phylogenetic tree based on support for the node (bootstrap or posterior probability) and the maximum pairwise genetic distance within the cluster.

Input

The CP takes as input a set of aligned sequences in fasta format and a newick tree built from those same sequences, with support values on the nodes. The user inputs the desired node support threshold and maximum genetic distance for clusters, as well as an initial support threshold for splitting the tree prior to analysis.

Algorithm

The CP utilizes a depth-first algorithm to explore the tree: starting at the root and working its way along each branch before backtracking when a leaf is reached. In order to minimize the number of pairwise distances computed (thus reducing running time), the tree is initially split. The user inputs an initial node support threshold, and starting from the root, the tree is divided into subtrees supported at this threshold. Further analyses will take place only within these subtrees; therefore, the initial support threshold must necessarily be smaller than or equal to the cluster support threshold. Starting from the root of the subtree, the CP proceeds to the first node exceeding the bootstrap support threshold. All sequences within the group are identified and their pairwise genetic distances are calculated. If the largest of these is smaller than or equal to the user-input maximum genetic distance threshold, the group of sequences is identified as a cluster. If the maximum pairwise distance is larger than the threshold, the cluster is rejected and the algorithm proceeds to the next supported node and repeats the same analysis. When a leaf is reached, the CP backtracks to the last node whose children have not been fully analyzed. When the algorithm has analyzed the entire tree, a list of clusters matching the user-input criteria is generated. Note that because the algorithm proceeds from the root towards the tips, nested clusters are not identified and do not appear in the final list.

Output

The CP outputs a log file listing for each cluster: cluster number, cluster size, maximum genetic distance within the cluster, support value and tip names. Also output are a fasta file in which sequence names are preceded by their cluster number and two trees, one in newick format and one in FigTree format (http://tree.bio.ed.ac.uk/software/figtree/). In both trees sequence names are preceded by cluster name, and in the FigTree file, sequence names are colored by cluster.

The Cluster Matcher

Objective

The CM is a JAVA based program which links clusters output by different CP runs based on the names of sequences within them. This can be done for CP runs on the same dataset, for example to examine changes following a change in method, or after the addition of new sequences to the dataset. The CM can also be used to identify clusters that meet certain criteria in double or single data set mode, outputting FigTree format files for each cluster. On top of this, the CM outputs a description of each cluster, for example summarizing epidemiological data associated with clustered sequences.

Input

The CM takes as input the newick files output by the CP and, as an option, corresponding annotation files. Inputting an annotation file allows the user to select clusters based on those annotations. For example, if the annotation file contains risk group data, the CM could output only clusters containing at least 50% of sequences from men who have sex with men (MSM). The user can also choose to output clusters based on whether they contain a specified minimum number of sequences.

Algorithm

Traversing from root-to-tip, the CM first identifies all clusters present in each dataset, linking every sequence in a cluster to any epidemiological information provided. The CM then examines clusters present in the first data set to determine if the sequences are clustered in the second data set. In this manner, each cluster from the first data set is linked to clusters in the second data set that contain matching sequences, and vice versa. For each cluster, information is retrieved including its size, number of matching sequences, and the distribution of epidemiological traits attached to its sequences. This allows the clusters to be easily filtered when the user specifies cluster selection criteria, and is used to generate summary information for each cluster.

Output

The CM outputs a FigTree file for each matching pair of clusters (or each cluster if used in single data set mode) that is consistent with user specifications, as well as a log file detailing settings and summarizing results. The FigTree file contains four trees showing the matched clusters in both trees, and a zoom into each of those clusters, allowing for the visualization of single clusters within large phylogenies.

Results

Data

Publicly available HIV pol sequences from the UK HIV Drug Resistance Database (HIVRDB; http://www.hivrdb.org) were used to evaluate the Cluster Picker and Cluster Matcher (Genbank IDs: EU236439-EU236538 [3], GQ462027-GQ462532 [18], JN100661-JN101948 [22]). Sequences were subtyped in Rega (http://dbpartners.stanford.edu/RegaSubtyping/), and cover the entire protease gene and up to 900 bases of reverse transcriptase. Sequences were stripped of 45 sites associated with drug resistance based on the 2011 updated drug resistance list [27]. In parallel, all unique subtype B pol sequences (HXB2 coordinates 2253 to 3549) with no insertions or deletions were downloaded from the Los Alamos National Laboratory HIV Sequence Database (http://www.hiv.lanl.gov) in order to perform speed comparison between the Cluster Picker and PhyloPart. Viral datasets for hepatitis C virus and influenza (avian, pandemic and seasonal) are analyzed in Additional file 1.

Effect of cluster thresholds on cluster distribution

Using the CP, we evaluated the effect of different cluster thresholds for genetic distance and cluster support on cluster identification among the UK subtype B sequences downloaded. One hundred replicate alignments were generated and a maximum likelihood tree with bootstraps was reconstructed in FastTree v2. 1. 4 [28] with a subtype C reference sequence (GenBank accession number: AY772699). The Cluster Picker runs on newick format trees generated in any program, as shown in Additional file 1.

Of 1831 downloaded sequences, 1381 unique subtype B sequences were used to examine the effect of cluster definition on cluster distribution using the CP. Although the phylogenetic tree contained a reference subtype C sequence, this outgroup was removed prior to analysis with the CP using the APE package v.3.0-8 in R [29, 30]. Initially, we fixed the bootstrap threshold in the CP at 90% and varied within-cluster maximum genetic distance between 1.5% and 7.5%. Between 4.5% and 7.5%, we found that for the most part, the same clusters were identified (Figure 1A). Within this range, the number of clusters stabilized around 128 (ranging from 126 to 131), with 2/3 containing only two sequences. At a genetic distance of 1.5%, only 63 clusters were identified. The proportion of sequences in clusters and average cluster size both increased as the genetic distance threshold was increased (Figure 2A). At a maximum genetic distance of 4.5%, 25% of sequences clustered, identical to the proportion found after a time-resolved analysis of the same sequences [3]. Beyond 4.5%, the ratio of these two measures became constant, indicating that as the genetic distance cut-off was relaxed sequences were being added equally to all clusters. The effect of varying the cluster bootstrap threshold was different; fixing the genetic distance at 4.5%, the proportion of sequences in clusters decreased gradually as bootstrap thresholds were increased from 70% to 99% (Figures 1B and 2B).

Figure 1
figure 1

Cluster distributions. 1381 subtype B UK sequences from NCBI were processed (A) through the Cluster Picker, with bootstrap support threshold fixed at 90% and maximum genetic distance threshold varied between 1.5% and 7.5%, (B) through the Cluster Picker with maximum genetic distance threshold fixed at 4.5% and bootstrap support threshold varied between 70% and 99%, and (C) through PhyloPart, with the t-percentile threshold varied between 1% and 30%.

Figure 2
figure 2

Clustering patterns. 1381 subtype B UK sequences from NCBI were processed (A) through the Cluster Picker, with bootstrap support threshold fixed at 90% and maximum genetic distance threshold varied between 1.5% and 7.5%, (B) through the Cluster Picker with maximum genetic distance threshold fixed at 4.5% and bootstrap support threshold varied between 70% and 99%, and (C) through PhyloPart, with the t-percentile threshold varied between 1% and 30%. Distribution for varying bootstrap thresholds. For each threshold, we plotted the percentage of total sequences in clusters (grey line) and average cluster size (dashed line).

Automated analysis of cluster dynamics

Using both the CP and the CM we reconstructed cluster dynamics over time, analyzing 409 non-B UK sequences as well as the 1381 subtype B sequences. These included 63 A subtypes, 219 C and 127 other non-B. All 1790 anonymised sequences had linked sampling date and location information in the HIVRDB. A phylogenetic tree was initially constructed from 1212 sequences of all subtypes collected up to 2005. A total of 148 clusters, containing 431 sequences (35.6%), were supported by a bootstrap ≥90% and had a maximum genetic distance ≤4.5%. One hundred and eight of these clusters were pairs, while the largest contained seventeen sequences. A second tree was built from the entire dataset of 1790 sequences and clusters matched between the early and late trees so that cluster changes could be described. In support of our initial cluster definition, the genetic distance of the new clusters increased above 4.5% only in two clusters despite the addition of 578 sequences, while bootstrap dropped below 0.90 only for six clusters (Figure 3). Finally, each clustered sequence was linked to sample location information in the HIVRDB and the CM was used to sort clusters in 2005 based on whether they contained sequences from a single sample location (“single” origin) or more (“multiple” origin). The UK HIV Drug Resistance Database categorizes geographical origin into 17 areas, all of which were represented in this dataset. A large proportion of sequences originate from the London area (one center). Patterns of change of single origin versus multiple origin clusters were compared (R script available in Additional file 2) [29]. Of 148 clusters, 63 were thus classified as multiple origin and 85 as single origin (Additional file 3). For each cluster, cluster growth was then calculated as the number of new sequences per initial sequence [25]. Mean cluster growth differed significantly between single and multiple origin clusters (0.155 vs. 0. 302, respectively, Kruskal-Wallis test: p = 0.0016; Additional file 2).

Figure 3
figure 3

Dynamics of a single cluster 2005-2007. In this example, the cluster identified in 2007 no longer matches the initial cluster definition as bootstrap support has dropped from 93% to 89%. Sequences A to G are those already in the cluster in 2005, starred sequences (H to K) have been added to the cluster in the intervening years.

Comparison with PhyloPart

We wished to compare the performance of the CP to PhyloPart, a recently released software tool for the identification of clusters [19]. PhyloPart generates the pairwise distance distribution for a tree and identifies a group of sequences as a cluster if the median of their genetic distances is below a user-input t-percentile threshold of the whole-tree distance distribution. The rooted subtype B tree containing 1381 sequences was analyzed in PhyloPart, varying the t-percentile threshold for cluster identification from 1% to 30%. Upon examination of the output, it appeared that this range reflected median genetic distances within clusters from 4.5% to 9% in the data. Once again, cluster distribution was not very much affected by the cut-off (Figure 1C), but the proportion of sequences in clusters and average cluster size increased as cluster definition was relaxed (Figure 2C). As a t-percentile threshold of 0.01 and 0.05 corresponded to genetic distance cut-offs of 4.5%, and 6.5%, respectively, the CP and PhyloPart output were compared in more depth at each of these two matched thresholds. Each time, the number of clusters and the cluster distributions were near identical (KS test, p = 0.9998 and p = 1 for 4.5% and 6.5% respectively). However, as expected, individual cluster sizes were significantly reduced when maximum within cluster genetic distance was used instead of median (Figure 4; one-sample sign test, p = 6.1*10-5 and p = 0.03 for genetic distances of 4.5% and 6.5%, respectively).

Figure 4
figure 4

Average cluster size according to clustering method. At thresholds of 4.5% and 6.5%, PhyloPart (in grey, median GD) and the Cluster Picker (dashed, maximum GD) identified nearly exactly the same number of clusters (numbers above the columns) but PhyloPart clusters were on average larger. GD genetic distance.

In order to make the comparison we ran both the CP and PhyloPart on 18 data sets sized 1000 to 18,000. A maximum likelihood tree with bootstraps was initially built from 18,000 sequences downloaded from Los Alamos. Then, sets of 1000 tips were dropped sequentially from the tree to generate trees with variable number of tips (Additional file 2). As PhyloPart does not print time to completion, it was launched from within a python script with an additional function to calculate running time (Additional file 4). Both programs were able to process trees with up to 17,000 sequences in less than an hour on a desktop (Table 1, Additional File 5), although PhyloPart did not terminate on the largest dataset (n = 18,000 sequences). The CP completed on average three times faster than PhyloPart.

Table 1 Time to completion (in seconds) of the Cluster Picker and PhyloPart for data sets of increasing sizes

Discussion

The tools that we present here can be used to investigate the dynamics of pathogen transmission. The CP is able to rapidly identify clusters in an automated way in large datasets, based on criteria demonstrated previously to accurately delineate epidemiologically relevant clusters [16]. Because in many cases cluster studies seek to combine genetic with epidemiological or clinical data (such as risk group or stage of infection), we have also made available the CM, which links clusters between runs and to epidemiological data. In contrast to some other methods available for the analysis of trait-annotated phylogenies [31, 32], the CM does not require any assumptions to be made about the heritability of the traits examined, as it does not look for associations between the distribution of traits and the phylogeny, only summarizes their distribution. As an example, we used the tools together to investigate the dynamics of single vs. multiple origin HIV clusters in the UK, as well as conduct preliminary analyses of HCV and influenza clustering.

There was remarkable consistency in the clusters identified at maximum genetic distances between 4.5% and 7.5%, as has been previously observed [3]. We conclude that these clusters represent well-delineated epidemiological units in the UK HIV epidemic. In contrast, when the maximum genetic distance threshold was decreased to 1.5%, only half of the clusters were identified. These clusters defined by such a short distance will reflect recent transmissions and frequent samplings [17]. In contrast, the UK HIVRDB contains mostly sequences from chronically infected patients, many of whom were first sequenced long after infection, and so in order to identify relevant clusters, a threshold of 4.5%, as we have used before [3, 18], is more appropriate. The effect of the bootstrap threshold was less evident, and so we conclude that genetic distance is the key parameter for epidemiologically relevant clustering. We stress however that the present analysis alone is not sufficient to yield a reusable definition of cluster threshold parameters, as the data set of publicly available sequences was too small for extensive testing. To resolve this issue, we are currently conducting in depth analyses on the UK HIVRDB as a whole (<50,000 sequences). Using the CP many thresholds can be examined very rapidly.

In order to highlight the CP’s suitability to other viruses and epidemic patterns, we conducted analyses of HCV and three datasets of influenza sequences (see Additional file 1). The CP was able to pick out meaningful pandemic flu clades consistent with earlier work [33], and the analysis of ladder-like seasonal influenza demonstrated the CP can accommodate different tree shapes, with sequences from the same year clustering together.

The CP uses maximum within cluster genetic distance, while PhyloPart, another recently released sequence clustering tool, uses the median. In previous studies, we have identified clusters in trees based on mean within cluster distance [18, 22]. However, we decided to use maximum genetic distance in our tool for three reasons. First, maximum genetic distance (as well as median genetic distance) is less affected by the number of sequences within a cluster (which can be the result of more or less intensive population sampling and contact tracing). When the mean is used, the distance is normalized by the total number of sequences in the cluster, potentially leading to clusters in which most of the sequences are very close together but one sequence is only distantly related to the group. Confirming this prediction, in our longitudinal analysis the genetic distance threshold did not have to be increased in 2007 to capture most 2005 clusters despite the additional of a large number of sequences. Second, maximum genetic distance is a metric more comparable to the time depth used to identify clusters in BEAST [22]. Third, maximum genetic distance is faster to compute, improving program efficiency. We nevertheless plan on adding alternative measures of genetic distance (mean and median) to future releases of the CP. Another difference between the programs is that distances are calculated de-novo from the sequences in the CP, while in PhyloPart, the patristic distances are used. Cluster definition in PhyloPart is a function of the whole tree: a subtree is classified as a cluster if its median genetic distance is smaller than a percentage of the whole tree. However, the user-specified genetic distance threshold in the CP allows external information to be incorporated into the definition, such as the average observed distance within transmission pairs if that is available. We chose this strategy because it is the most widely used definition; in fact, previous studies have demonstrated epidemiologically related viral sequences had less than 4.8% nucleotide substitutions between them [3]. Similarly, because studies vary in the bootstraps they use for support of clusters, we left this as a flexible option for the user to choose.

For data sets containing up to 17,000 sequences, both PhyloPart and CP yield results on a desktop in reasonable time. Theoretically, PhyloPart will slow down in large datasets, as it calculates all pairwise distances then stores them, so they can be accessed each time they are needed. This is an advantage for smaller datasets and speeds up processing, but for large trees, the time to generate matrices of all pairwise distances increases as a polynomial function of the number of sequences n (n (n-1)/2 computations). The CP calculates pairwise genetic distances within a potential cluster as required even if those distances were already calculated when the parent node was tested (and rejected). Nevertheless, the CP was not slower than PhyloPart on small datasets and in fact completed on average three times more rapidly. On large trees, it becomes faster to calculate subsets of pairwise genetic distances only within potential clusters, even if this must be repeated several times. Another alternative, not explored here, is the single-linkage approach proposed by Wertheim et al [34], which does not require a phylogenetic tree and calculates pairwise distances only once. With expanding sizes of HIV-1 data sets and other fast evolving pathogens, there is increasing need for new faster algorithms.

Conclusions

Our longitudinal cluster analysis demonstrated differences in cluster growth between clusters that were confined to single UK locations in 2005, and those that already contained sequences from several locations across the UK. If confirmed, these results suggest that targeting interventions on individuals within multiple origin clusters to prevent onward transmission would yield disproportionate results. Such real-time analyses are made possible by the CP and CM. As our purpose here was to demonstrate the functionality of the CP and CM, we chose a simple example. We hope that others will use the tools in more elaborate ways to truly provide insight into the dynamics of HIV transmission, as well as other infectious diseases. The CM, for example, can easily be used to compare clusters between trees built with different methods. Concerning cluster dynamics, we note that new sequences added to clusters do not necessarily reflect new infections: they could reflect new diagnoses within the time frame, and one potential explanation of the observed cluster growth may indeed be referral-based testing.

The automation of cluster picking and matching with epidemiological information is a necessary advance as pathogen sequence databases have become too large to analyze manually. The pol region of HIV is routinely sequenced for clinical purposes, and several European countries have created central repositories for the sequences. These data, combined with the tools we have made available, offer opportunities for the real-time surveillance of the HIV epidemic. We hope that by providing strategies for cluster identification and description, these user-friendly tools will facilitate comparisons of epidemics between studies and countries.

Availability and requirements

Project name: HIV Clusters in Phylogenetic Trees

Project home page: http://hiv.bio.ed.ac.uk/software.html

Operating system(s): Platform independent

Programming language: Java

Other requirements: Java 1.6.0 or higher

License: GNU GPLv3

Any restrictions to use by non-academics: no restriction

Abbreviations

CP:

Cluster Picker

CM:

Cluster Matcher

HIV:

Human immunodeficiency virus

HIVRDB:

UK HIV drug resistance database

UK:

United Kingdom.

References

  1. Holmes EC, Nee S, Rambaut A, Garnett GP, Harvey PH: Revealing the history of infectious disease epidemics through phylogenetic trees. Philos Trans R Soc Lond B Biol Sci. 1995, 349: 33-40. 10.1098/rstb.1995.0088.

    Article  CAS  PubMed  Google Scholar 

  2. Jenkins GM, Rambaut A, Pybus OG, Holmes EC: Rates of molecular evolution in RNA viruses: a quantitative phylogenetic analysis. J Mol Evol. 2002, 54: 156-165. 10.1007/s00239-001-0064-3.

    Article  CAS  PubMed  Google Scholar 

  3. Lewis F, Hughes GJ, Rambaut A, Pozniak A, Leigh Brown AJ: Episodic sexual transmission of HIV revealed by molecular phylodynamics. PLoS Med. 2008, 5: e50-10.1371/journal.pmed.0050050.

    Article  PubMed Central  PubMed  Google Scholar 

  4. Pilcher CD, Wong JK, Pillai SK: Inferring HIV transmission dynamics from phylogenetic sequence relationships. PLoS Med. 2008, 5: e69-10.1371/journal.pmed.0050069.

    Article  PubMed Central  PubMed  Google Scholar 

  5. Pilon R, Leonard L, Kim J, Vallee D, De RE, Jolly AM, Wylie J, Pelude L, Sandstrom P: Transmission patterns of HIV and hepatitis C virus among networks of people who inject drugs. PLoS ONE. 2011, 6: e22245-10.1371/journal.pone.0022245.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  6. Walsh PD, Biek R, Real LA: Wave-like spread of Ebola Zaire. PLoS Biol. 2005, 3: e371-10.1371/journal.pbio.0030371.

    Article  PubMed Central  PubMed  Google Scholar 

  7. Guan Y, Peiris JS, Zheng B, Poon LL, Chan KH, Zeng FY, Chan CW, Chan MN, Chen JD, Chow KY, et al: Molecular epidemiology of the novel coronavirus that causes severe acute respiratory syndrome. Lancet. 2004, 363: 99-104. 10.1016/S0140-6736(03)15259-2.

    Article  CAS  PubMed  Google Scholar 

  8. Twiddy SS, Farrar JJ, Vinh CN, Wills B, Gould EA, Gritsun T, Lloyd G, Holmes EC: Phylogenetic relationships and differential selection pressures among genotypes of dengue-2 virus. Virology. 2002, 298: 63-72. 10.1006/viro.2002.1447.

    Article  CAS  PubMed  Google Scholar 

  9. Kanemitsu K, Yamamoto H, Takemura H, Kaku M, Shimada J: Characterization of MRSA transmission in an emergency medical center by sequence analysis of the 3'-end region of the coagulase gene. J Infect Chemother. 2001, 7: 22-27. 10.1007/s101560170030.

    Article  CAS  PubMed  Google Scholar 

  10. He M, Miyajima F, Roberts P, Ellison L, Pickard DJ, Martin MJ, Connor TR, Harris SR, Fairley D, Bamford KB, et al: Emergence and global spread of epidemic healthcare-associated Clostridium difficile. Nat Genet. 2012, 45: 109-113. 10.1038/ng.2478.

    Article  PubMed Central  PubMed  Google Scholar 

  11. Watts DJ, Strogatz SH: Collective dynamics of ‘small-world’ networks. Nature. 1998, 393: 440-442. 10.1038/30918.

    Article  CAS  PubMed  Google Scholar 

  12. Cuevas MT, Fernández-García A, Sánchez-García A, González-Galeano M, Pinilla M, Sánchez-Martínez M, García V, Pérez-Álvarez L: Study group of HIV-1 newly diagnosed patients in Galicia, Spain. Incidence of non-B subtypes of HIV-1 in Galicia, Spain: high frequency and diversity of HIV-1 among men who have sex with men. Euro Surveill. 2009, 14: 47-Available online: http://www.eurosurveillance.org/ViewArticle.aspx?ArticleId=19413

    Google Scholar 

  13. Chalmet K, Staelens D, Blot S, Dinakis S, Pelgrom J, Plum J, Vogelaers D, Vandekerckhove L, Verhofstede C: Epidemiological study of phylogenetic transmission clusters in a local HIV-1 epidemic reveals distinct differences between subtype B and non-B infections. BMC Infect Dis. 2010, 10: 262-10.1186/1471-2334-10-262.

    Article  PubMed Central  PubMed  Google Scholar 

  14. Kaye M, Chibo D, Birch C: Phylogenetic investigation of transmission pathways of drug-resistant HIV-1 utilizing pol sequences derived from resistance genotyping. J Acquir Immune Defic Syndr. 2008, 49: 9-16. 10.1097/QAI.0b013e318180c8af.

    Article  CAS  PubMed  Google Scholar 

  15. Bezemer D, Van SA, Lukashov VV, Van Der Hoek L, Back N, Schuurman R, Boucher CA, Claas EC, Boerlijst MC, Coutinho RA, et al: Transmission networks of HIV-1 among men having sex with men in the Netherlands. AIDS. 2010, 24: 271-282. 10.1097/QAD.0b013e328333ddee.

    Article  PubMed  Google Scholar 

  16. Hue S, Clewley JP, Cane PA, Pillay D: HIV-1 pol gene variation is sufficient for reconstruction of transmissions in the era of antiretroviral therapy. AIDS. 2004, 18: 719-728. 10.1097/00002030-200403260-00002.

    Article  CAS  PubMed  Google Scholar 

  17. Mehta SR, Kosakovsky Pond SL, Young JA, Richman D, Little S, Smith DM: Associations between phylogenetic clustering and HLA profile among HIV-infected individuals in San Diego, California. J Infect Dis. 2012, 205: 1529-1533. 10.1093/infdis/jis231.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  18. Hughes GJ, Fearnhill E, Dunn D, Lycett SJ, Rambaut A, Leigh Brown AJ: Molecular phylodynamics of the heterosexual HIV epidemic in the United Kingdom. PLoS Pathog. 2009, 5: e1000590-10.1371/journal.ppat.1000590.

    Article  PubMed Central  PubMed  Google Scholar 

  19. Prosperi MC, Ciccozzi M, Fanti I, Saladini F, Pecorari M, Borghi V, Di GS, Bruzzone B, Capetti A, Vivarelli A, et al: A novel methodology for large-scale phylogeny partition. Nat Commun. 2011, 2: 321-

    Article  PubMed  Google Scholar 

  20. Heimer R, Barbour R, Shaboltas AV, Hoffman IF, Kozlov AP: Spatial distribution of HIV prevalence and incidence among injection drugs users in St Petersburg: implications for HIV transmission. AIDS. 2008, 22: 123-130. 10.1097/QAD.0b013e3282f244ef.

    Article  PubMed Central  PubMed  Google Scholar 

  21. Aldous JL, Pond SK, Poon A, Jain S, Qin H, Kahn JS, Kitahata M, Rodriguez B, Dennis AM, Boswell SL, et al: Characterizing HIV transmission networks across the United States. Clin Infect Dis. 2012, 55: 1135-1143. 10.1093/cid/cis612.

    Article  PubMed Central  PubMed  Google Scholar 

  22. Leigh Brown AJ, Lycett SJ, Weinert L, Hughes GJ, Fearnhill E, Dunn DT: Transmission network parameters estimated from HIV sequences for a nationwide epidemic. J Infect Dis. 2011, 204: 1463-1469. 10.1093/infdis/jir550.

    Article  PubMed Central  PubMed  Google Scholar 

  23. Brenner BG, Roger M, Routy JP, Moisi D, Ntemgwa M, Matte C, Baril JG, Thomas R, Rouleau D, Bruneau J, et al: High rates of forward transmission events after acute/early HIV-1 infection. J Infect Dis. 2007, 195: 951-959. 10.1086/512088.

    Article  CAS  PubMed  Google Scholar 

  24. Pao D, Fisher M, Hue S, Dean G, Murphy G, Cane PA, Sabin CA, Pillay D: Transmission of HIV-1 during primary infection: relationship to sexual risk and sexually transmitted infections. AIDS. 2005, 19: 85-90. 10.1097/00002030-200501030-00010.

    Article  PubMed  Google Scholar 

  25. Ragonnet-Cronin M, Ofner-Agostini M, Merks H, Pilon R, Rekart M, Archibald CP, Sandstrom PA, Brooks JI: Longitudinal phylogenetic surveillance identifies distinct patterns of cluster dynamics. J Acquir Immune Defic Syndr. 2010, 55: 102-108. 10.1097/QAI.0b013e3181e8c7b0.

    Article  PubMed  Google Scholar 

  26. Fisher M, Pao D, Brown AE, Sudarshi D, Gill ON, Cane P, Buckton AJ, Parry JV, Johnson AM, Sabin C, et al: Determinants of HIV-1 transmission in men who have sex with men: a combined clinical, epidemiological and phylogenetic approach. AIDS. 2010, 24: 1739-1747. 10.1097/QAD.0b013e32833ac9e6.

    Article  PubMed  Google Scholar 

  27. Johnson VA, Calvez V, Gunthard HF, Paredes R, Pillay D, Shafer R, Wensing AM, Richman DD: 2011 update of the drug resistance mutations in HIV-1. Top Antivir Med. 2011, 19: 156-164.

    PubMed  Google Scholar 

  28. Price MN, Dehal PS, Arkin AP: FastTree 2-approximately maximum-likelihood trees for large alignments. PLoS One. 2010, 5: e9490-10.1371/journal.pone.0009490.

    Article  PubMed Central  PubMed  Google Scholar 

  29. R Development Core Team: R: A language and environment for statistical computing. 2011, Vienna, Austria: R Foundation for Statistical Computing

    Google Scholar 

  30. Paradis E, Claude J, Strimmer K: APE: analyses of phylogenetics and evolution in R language. Bioinformatics. 2004, 20: 289-290. 10.1093/bioinformatics/btg412.

    Article  CAS  PubMed  Google Scholar 

  31. Chevenet F, Jung M, Peeters M, de Oliveira T, Gascuel O: Searching for virus phylotypes. Bioinformatics. 2013, 29: 561-570. 10.1093/bioinformatics/btt010.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  32. Parker J, Rambaut A, Pybus O: Correlating viral phenotypes with phylogeny: accounting for phylogenetic uncertainty. Infect Genet Evol. 2008, 8: 239-246. 10.1016/j.meegid.2007.08.001.

    Article  CAS  PubMed  Google Scholar 

  33. Nelson MI, Tan Y, Ghedin E, Wentworth DE, St GK, Edelman L, Beck ET, Fan J, Lam TT, Kumar S, et al: Phylogeography of the spring and fall waves of the H1N1/09 pandemic influenza virus in the United States. J Virol. 2011, 85: 828-834. 10.1128/JVI.01762-10.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  34. Wertheim JO, Leigh Brown AJ, Hepler NL, Mehta SR, Richman DD, Smith DM, Kosakovsky Pond SL: The global transmission network of HIV-1. J Infect Dis. 2013

    Google Scholar 

Download references

Acknowledgements

This work was supported by the Wellcome Trust (SJL, Grant number 092807) and the Biotechnology and Biological Science Research Council (EH and MRC, Grant number BB/F017030/1). The UK HIV Drug Resistance Database is supported by the Medical Research Council (grant number G0900274) and is partly funded by the Department of Health; the views expressed in the publication are those of the authors and not necessarily those of the Department of Health. Additional support for the HIVRDB is provided by Boehringer Ingelheim, Bristol-Myers Squibb, Gilead, Tibotec (a division of Janssen-Cilag) and Roche.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Manon Ragonnet-Cronin.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors’ contributions

MRC carried out the clustering analysis, comparative software testing and drafted the manuscript. SJL and EH designed and wrote the software. MRC and EH wrote the software tutorials, and SH and EF independently tested the software. SJL, EH, MRC, SH and AJLB participated in the initial design of the software. AJLB, MRC, SH, EF and VD participated in the data collection and interpretation of clustering results. AJLB, MRC, SJL and EH conceived of the study, participated in its design and coordination and helped to draft the manuscript. All authors read and approved the final manuscript.

Electronic supplementary material

12859_2013_6192_MOESM1_ESM.pdf

Additional file 1: Cluster Picker analysis of hepatitis C virus, avian influenza, pandemic influenza and H3N2 seasonal influenza.(PDF 593 KB)

12859_2013_6192_MOESM2_ESM.r

Additional file 2: R scripts for linking Cluster Picker and Cluster Matcher outputs and comparing growth of single vs. multiple origin clusters.(R 4 KB)

12859_2013_6192_MOESM3_ESM.pdf

Additional file 3: Figure S3: Largest UK cluster in 2007. This cluster had 17 sequences in 2007 and 33 in 2007. In 2005, the cluster contained sequences from four different regions (regions 1-4). Region U indicates a sequence from an unknown location. This figure was produced using the Cluster Matcher. (PDF 214 KB)

Additional file 4: Python script to launch PhyloPart in a loop.(PY 574 bytes)

12859_2013_6192_MOESM5_ESM.pdf

Additional file 5: Figure S5: Time to Completion and Computational Complexity. The time to completion (in seconds) of the Cluster Picker on subsamples of HIV dataset (see Table 1) is well approximated by f(N2) (N=number of sequences), indicating a computational complexity of O(N2). (PDF 184 KB)

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

Ragonnet-Cronin, M., Hodcroft, E., Hué, S. et al. Automated analysis of phylogenetic clusters. BMC Bioinformatics 14, 317 (2013). https://doi.org/10.1186/1471-2105-14-317

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-14-317

Keywords