Skip to main content

Unsupervised genome-wide recognition of local relationship patterns

Abstract

Background

Phenomena such as incomplete lineage sorting, horizontal gene transfer, gene duplication and subsequent sub- and neo-functionalisation can result in distinct local phylogenetic relationships that are discordant with species phylogeny. In order to assess the possible biological roles for these subdivisions, they must first be identified and characterised, preferably on a large scale and in an automated fashion.

Results

We developed Saguaro, a combination of a Hidden Markov Model (HMM) and a Self Organising Map (SOM), to characterise local phylogenetic relationships among aligned sequences using cacti, matrices of pair-wise distance measures. While the HMM determines the genomic boundaries from aligned sequences, the SOM hypothesises new cacti in an unsupervised and iterative fashion based on the regions that were modelled least well by existing cacti. After testing the software on simulated data, we demonstrate the utility of Saguaro by testing two different data sets: (i) 181 Dengue virus strains, and (ii) 5 primate genomes. Saguaro identifies regions under lineage-specific constraint for the first set, and genomic segments that we attribute to incomplete lineage sorting in the second dataset. Intriguingly for the primate data, Saguaro also classified an additional ~3% of the genome as most incompatible with the expected species phylogeny. A substantial fraction of these regions was found to overlap genes associated with both the innate and adaptive immune systems.

Conclusions

Saguaro detects distinct cacti describing local phylogenetic relationships without requiring any a priori hypotheses. We have successfully demonstrated Saguaro’s utility with two contrasting data sets, one containing many members with short sequences (Dengue viral strains: n = 181, genome size = 10,700 nt), and the other with few members but complex genomes (related primate species: n = 5, genome size = 3 Gb), suggesting that the software is applicable to a wide variety of experimental populations. Saguaro is written in C++, runs on the Linux operating system, and can be downloaded from http://saguarogw.sourceforge.net/.

Background

The phylogenetic relationship between organisms on a local genomic level does not always directly reflect the history of speciation. This can be due to well-known phenomena such as gene duplication and subsequent sub- and neo-functionalisation (reviewed in [1]), population subdivision and asymmetric gene flow [2], introgression [3], incomplete lineage sorting [4], hybridisation [5], copy number variation [6], and parallel adaptive evolution [7]. Identifying the regions subjected to these processes promises important insights into genome evolution, as we can relate these changes back to their expected biological roles, and in extension, the possible evolutionary pressures that ensured the survival of these regions within the studied population. We previously used a machine-learning algorithm that incorporated a Hidden Markov Model (HMM) [8] and a Self-Organising Map (SOM, a type of artificial neural network) [9], to investigate the genomes of sticklebacks. There, we detected distinct signatures of local phylogenies that are discordant with ancestry, which we could attribute to the effect of parallel adaptive evolution [7]. We now expand the scope of this algorithm and present the software, Saguaro.

A number of analysis tools have been developed to measure differences in local phylogenies, including but not limited to Phylo-HMM [10], SiPhy [11], and Coal-HMM [4, 12]. While these methods detect changes in phylogenetic tree size and branch lengths, or match local regions with a set of phylogenetic hypotheses, they lack a component to learn hypotheses directly from the data and without supervision. This is a particularly relevant limitation when analysing a large number of genomes, since these methods have no means of detecting patterns that were not anticipated. Saguaro fills the gap left by these methods in that it learns from the data without input of any a priori hypotheses. However, it does not provide the biological interpretation of its findings, but instead helps in generating new questions and perspectives.

At any given position in a multiple sequence alignment, the nucleotides in different genomes are either identical with each other, or not. Consequently, this local relationship is best described as a binary phylogeny that is built from this single nucleotide site. Wider branching patterns and branch lengths only become apparent as the average of adjacent binary trees, and from those, more meaningful phylogenetic patterns can be inferred. In order to accommodate a phylogeny that can be built up from such binary trees, Saguaro is based on the concept of a cactus. Given n genomes, a cactus is a symmetric matrix of n*n pairwise genome comparisons, where each element describes how different two genomes are relative to all other pairs. Restricting input sites to positions in which a minimum number of genomes differ from the rest normalizes the elements in the matrix, both in terms of phylogenetic branch lengths, as well as the branching itself. The purpose of a cactus is thus to represent segments of the genome in which consecutive input sites, as a whole, best match a particular cactus, without a cactus providing any immediate biological meaning. While the segmentation can be efficiently computed by a HMM, the next challenge is to a priori hypothesise the shape of the cactus that best represents the genomic segments. To achieve this, Saguaro utilises a SOM, which is an efficient unsupervised pattern recognition and classification algorithm. SOMs have been used in bioinformatics, including classification of the selectivity of inhibitors [13], image analyses of fungal colonies [14], and transcription factor binding site identification [15]. A feature that distinguishes a SOM from other clustering and classification algorithms is that it models the topology of the input data onto its neurons by reducing the dimensionality of the input space. In this regard, it can be considered a non-linear generalisation of Principal Components Analysis [16], which is a widely used multivariate analysis algorithm to automatically group data points by patterns. The purpose of Saguaro’s SOM is to iteratively build up a set of cacti differing in the phylogeny that they describe, so that the local relationship between sequences in each region is well represented by at least one cactus.

Here, we first explain the methods behind Saguaro, and continue by presenting results from analyses using two different data sets: (i) many genomes of short lengths: 181 strains of the Dengue virus serotype 3 isolated from different geographical locations over several years and from various outbreaks [17]; and (ii) few, but complex, large genomes: five primates including human, chimpanzee, gorilla, orang-utan, and macaque.

Implementation

Saguaro’s basic workflow is shown in Figure 1a. After the genomes have been aligned, Saguaro first builds one cactus from all differences found in the entire genome, and then iteratively adds more cacti to refine representations for different subsets of the genome. In each iteration, it scores each nucleotide site against a set of cacti, using the HMM to determine segment boundaries. Then, Saguaro re-computes each cactus based on the sites in its segments to further improve the cactus’ representation of its sites. Saguaro then trains a SOM for each cactus. This allows the software to further partition the pattern space, identifying genomic regions that are not well modelled by any of the cacti in the current set, and hypothesise additional cacti that are more representative of these regions. Each SOM is trained with randomly chosen sites from regions assigned to its cactus so that the neurons model local patterns from these positions (see section “Self Organising Map”). This subdivision of the input space serves to hypothesise new cacti by examining the shape of the SOM after training.

Figure 1
figure 1

Saguaro ’s workflow. (a) Saguaro takes genome-wide aligned nucleotide sites in genomic order as input. The filtering of non-informative nucleotides is configurable. A Hidden Markov Model (HMM) scores each site against cacti and segments the genome by the best statistical fit. Each cactus is then re-computed by all the sites it represents. This step can be repeated to refine both the segmentation and the cactus. To augment the set of cacti, Saguaro trains one Self Organizing Map (SOM) per cactus from all the sites residing in segments represented by this cactus. In each SOM, Saguaro then finds the neuron that best represents its sites, and based on that, determines the neuron farthest from that as the worst representative given its sites. Saguaro then picks the SOM with the longest distance between the best and worst neurons and hypothesises a new cactus from this worst neuron. This cactus is passed back to the HMM which assigns segments to it. (b) Shown is a low-level schematic of how Saguaro processes input into output. During the SOM stage, input sites are translated into binary vectors of 1’s (mismatch, black) and 0’s (matches, white), relative to a randomly chosen genome that serves as the ‘reference’. The SOM is then presented with these vectors in random order, so that the continuous vectors contained in the neurons model the input space. The most common input pattern results in the highest density of neurons, whereas patterns not well-modelled by these neurons form their own cluster (shown in red). These neurons are then expanded into a cactus, and added to the HMM’s set. The HMM then re-segments the genome and re-trains the cacti. This process is repeated iteratively in order to build a set of cacti that model different subsets of the genome via their patterns.

Figure 1b is a schematic of the inner mechanisms of Saguaro. After segmenting the genome into regions, the SOM is presented with random sites from regions assigned to the same cactus. Input sites are transformed into binary vectors where white indicates nucleotide matches and black represent mismatches. The SOM is trained from binary vectors into neurons that are represented by continuous vectors. As a result, the neurons cluster by frequency of input patterns, with the most prominent pattern forming the tightest cluster with the highest density of data points. Saguaro then finds the second-most weighted cluster at a minimum distance from the highest weighted cluster, representing input sites that are most abundant in the input data but least well modelled by the cactus they were assigned to. The data vector from these neurons is then expanded into a cactus and added to the HMM’s set of cacti. In the next round of iterations, the HMM re-segments the input data and re-estimates all cacti. This process is repeated for a set number of iterations, after which the final output is computed as a segmentation of the input sequences into different phylogenetic patterns for further examination and biological interpretation.

Input and output formats

Input data needs to be converted into Saguaro-native binary format. Saguaro provides conversion tools for Multiple Alignment Format (MAF), Variant Call Format (VCF), and multi-FASTA format of aligned genomes. Filtering out uninformative sites is configurable and implemented during conversion. At the end, Saguaro also computes a local cactus for each individual region.

Hidden Markov Model (HMM)

The states of the HMM are defined by cacti, applying a flat penalty when transitioning between states and requiring a minimum stay duration of three consecutive nucleotide sites, modelled by three sequential states. Given n genomes, for each nucleotide site, we construct the observed matrix O of size n*n, which is a binary matrix of 0’s (match) and 1’s (mismatch) based on pairwise comparisons. We next define the scoring scheme S(H,O) to compare a cactus H to matrix O. We can think of a possible nucleotide substitution between genome i and j (ij) as a Poisson process with parameter H i,j representing a measure for the distance between genome i and j compared to all other pairwise comparisons. Since the observed number of substitutions O i,j is either 0 or 1, the likelihood l i,j of the individual observation O i,j is:

l i , j = e H i , j O i , j = 0 1 e H i , j O i , j = 1

Which can be summarised in one expression as:

l i , j = e H i , j + O i , j 2 O i , j e H i , j

Assuming independence across all genomes, the likelihood L(O,H) of the entire observation O is the product of all the individual likelihoods l i,j . This gives:

L O , H = i j e H i , j + O i , j 2 O i , j e H i , j

L(O,H) is positive as long as H i,j ≠ 0. We let the final score, S(H,O), be the log of the likelihood score L(H,O):

S O , H = H i , j 0 log e H i , j + O i , j 2 O i , j e H i , j

If genome i or j (or both) do not have any information at the given position, we set O i,j = −1. The score S(H,O) is then:

S O , H = H i , j 0 O i , j 1 log e H i , j + O i , j 2 O i , j e H i , j

Subsequent to each segmentation, we update all cacti by modifying H to represent more of the observations indexed by the set R N. We minimise the total score S’ of H over all the observations:

S ' H , R = r R S H , O r

Since S(H, O r ) is the sum of log likelihood scores over all genome pairs, we can optimise each H i,j individually.

For a single pair of genomes (i, j), let:

a0 = the number of observations in {O r } in which genome i and j agree

a1 = the number of observations in {O r } in which genome i and j disagree

Undefined observations are not included. We thus maximise the total score over all observations

S ' i , j = r R log e H i , j + O i , j 2 O i , j e H i , j = a 0 H i , j + a 1 log 1 e H i , j

S’ i,j is a differentiable function of H i,j which attains its maximum at

H * i , j = log a 0 a 0 + a 1 a 0 0 a 0 = 1

Thus, we update H for the data in {O r } by setting:

H i , j = log a 0 a 0 + a 1 a 0 0 log a 1 a 0 = 1

for all pairs (i,j).

Self Organizing Map (SOM)

Saguaro’s Self Organizing Map (SOM) is organised in a circle. Given the number of genomes n, each neuron contains a vector f with size n, and its elements f i are initially assigned random values between 0 and 1. To train the neural network, input positions are randomised in order, and each input position is converted into a vector l of size n, with each element l i either set to 0 or 1, depending on whether the nucleotides are identical (0) or not (1) compared to one randomly chosen genome that serves as the reference for the site. We then compute the distance between this vector and each vector fj of neuron j as:

d j = min i f i j l i 2 n , i f i j 1 l i 2 n

Based on this distance measure, we determine the neuron g with the shortest distance. All neurons j are then updated as:

f i j ' = f i j 1 w + w l i

where the weight w is defined as:

w = h min j g 2 , N j g 2 + 1

with N being the number of neurons, and h monotonically decreasing with the number of processed input sites.

Parameter choice

Saguaro has two main parameters: (i) the penalty applied by the HMM when transitioning between different cacti, and (ii) the number of neurons in the self-organizing map. To investigate parameter sensitivity, we previously applied Saguaro to genomic re-sequencing data from the twenty populations of sticklebacks in which we previously identified signatures of adaptive evolution using this method, as well as a hypothesis-driven statistical approach [7]. We ran Saguaro on all of chromosome IV with transition penalties of 50, 100, 150, and 200. For values of 50, 100, and 150, Saguaro found the signature of adaptive evolution within four iterations, while a transition penalty of 200 required seven iterations, suggesting a drop-off in sensitivity above 150. We next varied the number of SOM neurons, using 200, 400, and 800 respectively. While 400 and 800 neurons yielded identical results over the first five iterations, the use of 200 neurons required one additional iteration before the signature was found, suggesting a drop in sensitivity at this value or lower. After 20 iterations, each run yielded very similar results, suggesting that (apart from using extreme values) the choice of parameters mostly affects runtime, and that the algorithm is robust with regards to parameter settings. Based on the test above and in absence of any training data particular to the data sets, we selected a transition penalty of 150 and 800 SOM neurons for the analyses described here, the same values that were used in the stickleback study.

Results

Simulated data

We first generated a simulated data set, based on a 100 Kb genome. Genomes for 10 individuals were simulated in blocks of random size (50–2000 nucleotides) using the program Dawg [18] version 1.2 by specifying one of four phylogenies (Figure 2a) with mutations at a rate of 0.1-1% per generation. In order to simulate uneven abundance of these phylogenies, we set the probabilities to 0.5, 0.25, 0.125, and 0.0625 to choose these phylogenies, allowing for consecutive blocks of the same phylogeny. Figure 2b shows a visual representation of Saguaro’s output after different numbers of iterations, compared to the “truth” input set for the simulation at the top. For comparison, we computed local phylogenies and coloured the segments according to which simulated phylogeny was most closely matched, as determined by TOPD [19]. As soon as in the second iteration, where only two cacti are available for segmentation, Saguaro starts detecting segment boundaries correctly. After 16 iterations, Saguaro segments the genome into blocks closely resembling the truth, with the shortest block being 91 bp long and containing 3 SNP's. Only one 170 nucleotide long region with 9 SNPs was not identified correctly (red line in the upper right corner in Figure 2b).

Figure 2
figure 2

Simulated data. (a) We simulated the genomes of 10 individuals grouped into 5 populations or species, labelled A, E, G, P and S. We segmented the genomes in blocks of 50 to 1000 nucleotides and assigned different local phylogenies at different frequencies, with the tree depicted in grey covering most of the genome and black the least coverage. (b) Shown is the comparison of Saguaro’s segmentation with the simulated truth (top). After iteration 16, Saguaro segments the genome correctly according to the simulation, with the exception of one block containing 9 SNPs. (c) We varied the divergence between genomes from 0 to 0.2 and computed the fraction of all nucleotides, including invariant sites, that was assigned to regions in which topology agrees with the simulation (green), disagrees (red), or falls in invariant regions at segmentation boundaries (blue).

In order to determine sensitivity, we next varied the divergence rates from 0 to 0.02 (Figure 2c). To measure the performance of the segmentation, we computed tree topologies for each segment, and counted the percentage of the genome that was either: (a) assigned to a topology accurately representing the simulation (“correct”); (b) assigned to a topology different from the simulation (“wrong”); and (c) the percentage not assigned to any cactus, i.e. invariant regions between SNPs at the segment boundaries (“missing”). As expected, assignments were more accurate with increasing divergence, starting to level out at around 0.002 (Figure 2c).

Local pattern variation in Dengue virus phylogeny

Dengue viruses are mosquito-borne single-stranded RNA viruses of the Flaviviridae family that infect humans with between 50 to 100 million cases reported every year [20]. Over several years, 181 Dengue virus serotype 3, strains have been collected from various geographic locations in Central and South America (Venezuela, Colombia, Brazil, Puerto Rico, Nicaragua, Caribbean) as well as Asia (Sri Lanka, Thailand) [17]. Schmidt et al. reported that the genome-wide phylogeny is reflective primarily of geographic location, but also of the year of outbreak. The Dengue virus genome size is small at around 10,660 nucleotides, and we thus hypothesise that selection criteria may exert pressure on very localised regions in the virus. To explore this, we first extracted a total of 1260 single nucleotide differences and short insertions and deletions (indels) from multiple sequence alignments [17]. Variants supported by at least three Dengue virus strains were classified as phylogenetically informative. Iterative runs of Saguaro produced five different cacti, with cacti 1 to 4 being very similar to each other, but with cactus 5 being distinct. To independently validate whether these cacti describe changes in local phylogeny, we used a pipeline [21] consisting of MUSCLE [22], Gblocks [23], and PhyML [24] to re-align different genomic sequences segmented into cacti directly, and to build a phylogeny based on all nucleotides, including identical sites. A Dengue virus serotype 1 sequence was used as outgroup in the phylogeny.

Phylogenies based on regions covered by cactus 1 through 4 closely resembled previous findings [17], namely that phylogeny followed geographic sampling and year of outbreak (Figure 3a). By contrast, the phylogeny built from the regions identified by cactus 5, which cover 12.6% of the genome in 34 distinct loci, is clearly different (Figure 3b). The sequences from Thailand (light green) show little within-group divergence and form an independent cluster separate from the shorter, collapsed branch lengths of the Central and South American Dengue virus sequences. This group of American Dengue virus strains were collected from recent outbreaks in the early 2000’s and cluster with sequences representing outbreaks in the early 1980’s in Sri Lanka (light blue) and Mozambique (dark green), suggesting shared evolutionary constraint. This phylogeny is consistent with the reported spread of these epidemics from Sri Lanka, through Africa, and into the Caribbean and the Americas in the mid 1980’s [25].

Figure 3
figure 3

Lineage-specific conservation in the Dengue virus genome. (a) The phylogeny generated by the regions assigned to the most prevalent cactus was found to closely resemble previous findings [17]. Sequence from Dengue virus serotype 1 was used to root the tree. (b) In contrast, the phylogeny based on the most discordant cactus (cactus 5), groups the sequences of all viruses together with the exception of those representing the Thai Dengue virus strains. (c) Sequence conservation across the viral genome is plotted for all strains (grey) and after excluding strains from Thailand (black). While the highest level of conservation among all strains is located close to the 3’ end of the virus, the highest conservation peak after excluding the Thai strains coincides with the longest region assigned to cactus 5, indicating high levels of lineage-specific sequence conservation. Shown at the bottom are also all regions modelled by cactus 5 (dark pink).

Closer examination of cactus 5 revealed that the longest continuous region was derived from five nucleotide sites spanning 120 bases in the 3’ untranslated region (UTR) of the 3390 amino acid polyprotein Open Reading Frame (ORF). The identification of this signal prompted us to use overlapping sequence windows to test the entire Dengue virus genomes for signs of overall and strain-specific nucleotide conservation. For each nucleotide position l in the multiple sequence alignment where at least one genome had a mismatch with another, we determined the smaller number of genomes n l that differed from each other (analogous to the concept of minor allele frequencies, e.g. if 82 sequences have a C and 99 have a T, then n = 82). For each l, we then report

c l = i = l 60 l + 60 n i 1

as a measure of conservation at site l.

Figure 3c shows the result graphically, plotting the calculated sequence conservation against the physical length of the viral genome. The value determined using all genome sequences (grey) is illustrated in contrast to that generated by all sequences except those sourced from Thailand (black). While the strongest signal of overall conservation is located close to the 3’ end of the genome (Figure 3c, dotted box, grey), the signal extends in the 5’ direction when the Thai sequences are excluded. This latter signal, masked when overall conservation is computed, is identical to the region identified by cactus 5, and shows signatures of strain-specific conservation in two groups, both the Thailand strains as well as the other strains.

Genes involved in the immune system leave a distinct trace in five primate genomes

We extracted the human, chimpanzee, gorilla, orang-utan and macaque genomes from the Multiz-44 multiple sequence alignments that were used in the analysis of 29 mammalian genomes [26] and imposed filters to mask transposable elements and simple repeats, leaving only positions in which all genomes aligned. After also removing private SNPs, i.e. positions in which only one genome was different and all others were the same, we were left with ~9.47 million positions from which Saguaro produced 35 cacti. Figure 4a shows a neighbour joining distance tree of cacti based on their pair-wise Euclidean distances. Rather than exhibiting a star-like shape, which would indicate many different patterns, cacti are placed into four main clades. The top clade (Figure 4a, grey box containing cacti 0–2, 6, 9) captures mostly shared sequence ancestry and covers ~97% of the genome. Phylogenies computed from this dominant clade are similar to each other in terms of branching pattern and length. Notably, cacti representing close to one third of the aligned genomes transposed the relationships between gorilla, chimpanzee and human. This is consistent with previous reports that attribute these regions to the effect of incomplete lineage sorting [27].

Figure 4
figure 4

Cacti computed from five primate genome alignments. (a) A neighbour joining distance tree groups the cacti into four major clades, with clade 1 (grey) covering 97% of the bases assigned to its genomic segments. The cacti in clades 2–4 (light green, blue and red) and cacti 12 and 15 (dark green) represent the remaining 2.3% and 0.7% of the genome respectively. (b) A human-centric ideogram illustrates the distribution of regions assigned to each cacti condensed into clades (1–4) and cacti 12 and 15. While clade 1 describes most of the genome, genomic regions that are better represented by cacti outside of clade 1 are distributed throughout the genome.

Outside of clade 1, there are 30 cacti identifying 747 disjoint regions. Figure 4b shows a human-centric view of the genome-wide distribution of cacti. This ideogram has been coloured to aid visualisation (clade 1, grey; clade 2, yellow; clade 3, blue; clade 4, red; outlier groups cacti 12 and 15 green). Clades 2–4 and the outlier cacti overlap with the introns or exons of 1,159 coding (362) or non-coding (797) genes (Ensembl gene build 64). About 33% (381) of these genes are processed (181) or unprocessed (200) pseudogenes, and an additional 276 non-coding RNAs contain lincRNAs (118), microRNAs (38), and snoRNAs (120). Gene families with more than five members included six synovial sarcoma × genes, 12 UDP glucuronosyltransferases, eight cytochromes, 15 olfactory receptors and two taste receptors, 13 keratins and keratin associated proteins and 14 PRAME family members. Of the 20 zinc finger proteins targeted by this analysis, most were located on chromosome 19 where zinc finger clusters are known to have undergone recent expansions [28]. Interestingly, genes transcribed to form the variable parts of antibodies for Immunoglobolin D (n = 20) and Immunoglobolin V (n = 36) figured prominently, as did Immunoglobolin V pseudogenes (n = 37). Other immunology-related findings included immunoglobulin lambda-like polypeptide 1 (IGLL1), immunoglobulin superfamily member 3 (IGSF3), 13 HLA genes located in the major histocompatibility complex, eight interferon alpha genes, and the interferon gamma-inducible protein 16 (IFI16). GO-term analysis using Ingenuity PA (http://www.ingenuity.com/) recovered additional genes involved in inflammatory/immune response (p = 0.017). Among the top ranked genes (in terms of p-value) were APOL1, APOL3, APP, CASP1, CASP5, CEACAM1, CR1, CROCC, CSF2RB, CXCL6, E2F2, GBA, GGT5, KIR3DL1, MYLK, NBN, NOS2, PARP4, RABGEF1, TNFRSF10B, TNFRSF14, ULBP2, and XBP1.

Conclusions

While an HMM can accurately segment a stream of features into various patterns, it lacks the ability to a priori hypothesise what these patterns are. Conversely, a SOM will cluster signals into distinct patterns automatically, albeit without a spatial component to allow for determination of signal patterning. Through the interleaved application of both algorithms, Saguaro allows the strengths of each approach to be exploited. Saguaro’s features are nucleotide positions in which genomes are compared, and its patterns, cacti, are matrices that robustly model the phylogenetic relationships between organisms.

We demonstrated that Saguaro was successfully able to process two data sets at opposite ends of the spectrum; one with many sequences of short lengths, the other with few but complex and large sequences, and in each case identify local phylogenetic branching patterns that differed from the phylogeny as a whole. In 181 strains of Dengue virus serotype 3 [17], we find a 120 nucleotide long region in the 3’UTR (Figure 3c) previously described to contain functional RNA loop structures [29]. This region appears to be under constraint in a lineage-specific manner, and does not appear as a strong signal when looking for conservation across all strains. Moreover, Saguaro found this region when only examining the pattern of five informative nucleotide sites, ignorant to the invariant nucleotide positions in between. In primates, Saguaro finds four clades of cacti, including one representing the phylogenetic background of the species (Figure 4, clade 1 representing 97% of the genome). In that major clade, one third of the sequence resided in slightly shuffled phylogenies, which, in keeping with a similar fraction previously reported for the gorilla genome, we attribute to incomplete lineage sorting [27]. In addition, Saguaro assigns 3% of the aligned genomes to cacti that reside outside of clade 1. Many of these regions overlap with non-coding and coding genes, such as olfactory and taste receptors, as well as zinc finger proteins that could be involved in the regulation of a number of cellular processes. However the strongest signal was associated with inflammatory and immune response genes, sequences that are also known to be highly variable in human populations [30]. Interestingly, a large number of pseudogenes were also identified. Assuming that these are the product of duplications, this finding would not be surprising, as pseudogenisation is considered a common outcome of such duplication events. We note that Saguaro is agnostic to the underlying mechanisms that give rise to its cacti, and that if the data contains systematic artefacts, it will likely report them as signals represented by their own cacti. This is a particularly relevant caveat in the case of genomic regions that are inherently difficult to assemble correctly from Whole Genome Shotgun reads, and some of these regions identified in our study of primates, e.g. the major histocompatibility complex (MHC), fall into this category. We thus manually inspected a number of additional regions assigned to the same cactus as the MHC, and found that the majority showed no obvious reasons as to why those should contain assembly errors.

An organism’s ability to adapt and thrive in a given environment is a product of many complex genetic interactions. We expect that the fields of genomics and population genetics will be able to exploit the novel combination of a Hidden Markov Model and a Neural Network contained within Saguaro to investigate existing and future data sets with a fresh perspective. The examination of phylogenies without the constraint of a priori assumptions may reveal previously hidden relationships, such as those between hosts and their pathogens, or offer insight into previously unknown biological drives.

Availability and requirements

Project name: SaguaroGW

Project web site: http://saguarogw.sourceforge.net/

Operating systems: GNU/Linux

Programming language: C++ (Saguaro), perl (data simulation)

Compiler: gcc 4.6.3

Minimum RAM: 4GB, 64+GB recommended

License: free to all users under the LGPL license

References

  1. Hahn MW: Distinguishing among evolutionary models for the maintenance of gene duplicates. J Hered. 2009, 100: 605-617. 10.1093/jhered/esp047.

    Article  CAS  PubMed  Google Scholar 

  2. Tiffin P, Olson MS, Moyle LC: Asymmetrical crossing barriers in angiosperms. Proc Biol Sci/Roy Soc. 2001, 268: 861-867. 10.1098/rspb.2000.1578.

    Article  CAS  Google Scholar 

  3. Dowling TE: Secor and CL: the role of hybridization and introgression In the diversification of animals. Annu Rev Ecol Evol Syst. 1997, 28: 593-619. 10.1146/annurev.ecolsys.28.1.593.

    Article  Google Scholar 

  4. Hobolth A, Dutheil JY, Hawks J, Schierup MH, Mailund T: Incomplete lineage sorting patterns among human, chimpanzee, and orangutan suggest recent orangutan speciation and widespread selection. Genome Res. 2011, 21: 349-356. 10.1101/gr.114751.110.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  5. White MA, Ané C, Dewey CN, Larget BR, Payseur BA: Fine-scale phylogenetic discordance across the house mouse genome. PLoS Genet. 2009, 5: e1000729-10.1371/journal.pgen.1000729.

    Article  PubMed Central  PubMed  Google Scholar 

  6. Hastings PJ, Lupski JR, Rosenberg SM, Ira G: Mechanisms of change in gene copy number. Nat Rev Genet. 2009, 10: 551-564.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  7. Jones FC, Grabherr MG, Chan YF, Russell P, Mauceli E, Johnson J, Swofford R, Pirun M, Zody MC, White S, Birney E, Searle S, Schmutz J, Grimwood J, Dickson MC, Myers RM, Miller CT, Summers BR, Knecht AK, Brady SD, Zhang H, Pollen AA, Howes T, Amemiya C, Baldwin J, Bloom T, Jaffe DB, Nicol R, Wilkinson J, Lander ES: The genomic basis of adaptive evolution in threespine sticklebacks. Nature. 2012, 484: 55-61. 10.1038/nature10944.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  8. Baum LE, Petrie T: Statistical inference for probabilistic functions of finite state Markov chains. Ann Math Stat. 1966, 37: 1554-1563. 10.1214/aoms/1177699147.

    Article  Google Scholar 

  9. Kohonen T: The self-organizing map. Proc IEEE. 1990, 78: 1464-1480. 10.1109/5.58325.

    Article  Google Scholar 

  10. Siepel A, Bejerano G, Pedersen JS, Hinrichs AS, Hou M, Rosenbloom K, Clawson H, Spieth J, Hillier LW, Richards S, Weinstock GM, Wilson RK, Gibbs RA, Kent WJ, Miller W, Haussler D: Evolutionarily conserved elements in vertebrate, insect, worm, and yeast genomes. Genome Res. 2005, 15: 1034-1050. 10.1101/gr.3715005.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  11. Garber M, Guttman M, Clamp M, Zody MC, Friedman N, Xie X: Identifying novel constrained elements by exploiting biased substitution patterns. Bioinf (Oxford, England). 2009, 25: 54-62. 10.1093/bioinformatics/btn354.

    Article  Google Scholar 

  12. Wu Y: Coalescent-based species tree inference from gene tree topologies under incomplete lineage sorting by maximum likelihood. Evol Int J Org Evol. 2012, 66: 763-775. 10.1111/j.1558-5646.2011.01476.x.

    Article  Google Scholar 

  13. Wang L, Wang M, Yan A, Dai B: Using self-organizing map (SOM) and support vector machine (SVM) for classification of selectivity of ACAT inhibitors. Mol Divers. 2013, 17: 85-96. 10.1007/s11030-012-9404-z.

    Article  CAS  PubMed  Google Scholar 

  14. Marique T, Allard O, Spanoghe M: Use of self-organizing map to analyze images of fungi colonies grown from triticum aestivum seeds disinfected by ozone treatment. Int J Microbiol. 2012, 2012: 865175-

    Article  PubMed Central  PubMed  Google Scholar 

  15. Mahony S, Hendrix D, Golden A, Smith TJ, Rokhsar DS: Transcription factor binding site identification using the self-organizing map. Bioinf (Oxford, England). 2005, 21: 14-1807.

    Article  Google Scholar 

  16. Gorban AN, Kgl B, Wunsch DC, Zinovyev A: Principal Manifolds for Data Visualization and Dimension Reduction. 2007

    Google Scholar 

  17. Schmidt DJ, Pickett BE, Camacho D, Comach G, Xhaja K, Lennon NJ, Rizzolo K, De Bosch N, Becerra A, Nogueira ML, Mondini A, Da Silva EV, Vasconcelos PF, Muñoz-Jordán JL, Santiago GA, Ocazionez R, Gehrke L, Lefkowitz EJ, Birren BW, Henn MR, Bosch I: A phylogenetic analysis using full-length viral genomes of South American dengue serotype 3 in consecutive Venezuelan outbreaks reveals a novel NS5 mutation. Infect Genet Evol J Mol Epidemiol Evol Genet Infect Dis. 2011, 11: 2011-9.

    Article  CAS  Google Scholar 

  18. Cartwright RA: DNA assembly with gaps (Dawg): simulating sequence evolution. Bioinf (Oxford, England). 2005, 21 (3): 8-31.

    Google Scholar 

  19. Puigbò P, Garcia-Vallvé S, McInerney JO, Puigbò P, Garcia-Vallvé S, McInerney JO: TOPD/FMTS: a new software to compare phylogenetic trees. Bioinf (Oxford, England). 2007, 23: 8-1556.

    Article  Google Scholar 

  20. WHO: Dengue Guidelines for Diagnosis. 2009, Treatment, Prevention and Control. Geneva, 3-

    Google Scholar 

  21. Dereeper A, Guignon V, Blanc G, Audic S, Buffet S, Chevenet F, Dufayard J-F, Guindon S, Lefort V, Lescot M, Claverie J-M, Gascuel o: Phylogeny.fr: robust phylogenetic analysis for the non-specialist. Nucleic Acids Res. 2008, 36: W465-9. 10.1093/nar/gkn180.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  22. Edgar RC: MUSCLE: multiple sequence alignment with high accuracy and high throughput. Nucleic Acids Res. 2004, 32: 1792-7. 10.1093/nar/gkh340.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  23. Talavera G, Castresana J: Improvement of phylogenies after removing divergent and ambiguously aligned blocks from protein sequence alignments. Syst Biol. 2007, 56: 564-77. 10.1080/10635150701472164.

    Article  CAS  PubMed  Google Scholar 

  24. Guindon S, Dufayard J-F, Lefort V, Anisimova M, Hordijk W, Gascuel O: New algorithms and methods to estimate maximum-likelihood phylogenies: assessing the performance of PhyML 3.0. Syst Biol. 2010, 59: 307-21. 10.1093/sysbio/syq010.

    Article  CAS  PubMed  Google Scholar 

  25. Messer WB, Gubler DJ, Harris E, Sivananthan K, De Silva AM: Emergence and global spread of a dengue serotype 3, subtype III virus. Emerging Infectious Dis. 2003, 9: 800-9. 10.3201/eid0907.030038.

    Article  Google Scholar 

  26. Lindblad-Toh K, Garber M, Zuk O, Lin MF, Parker BJ, Washietl S, Kheradpour P, Ernst J, Jordan G, Mauceli E, Ward LD, Lowe CB, Holloway AK, Clamp M, Gnerre S, Alföldi J, Beal K, Chang J, Clawson H, Cuff J, Di Palma F, Fitzgerald S, Flicek P, Guttman M, Hubisz MJ, Jaffe DB, Jungreis I, Kent WJ, Kostka D, Lara M: A high-resolution map of human evolutionary constraint using 29 mammals. Nature. 2011, 478: 476-82. 10.1038/nature10530.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  27. Scally A, Dutheil JY, Hillier LW, Jordan GE, Goodhead I, Herrero J, Hobolth A, Lappalainen T, Mailund T, Marques-Bonet T, McCarthy S, Montgomery SH, Schwalie PC, Tang YA, Ward MC, Xue Y, Yngvadottir B, Alkan C, Andersen LN, Ayub Q, Ball EV, Beal K, Bradley BJ, Chen Y, Clee CM, Fitzgerald S, Graves TA, Gu Y, Heath P, Heger A: Insights into hominid evolution from the gorilla genome sequence. Nature. 2012, 483: 169-175. 10.1038/nature10842.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  28. Grimwood J, Gordon LA, Olsen A, Terry A, Schmutz J, Lamerdin J, Hellsten U, Goodstein D, Couronne O, Tran-Gyamfi M, Aerts A, Altherr M, Ashworth L, Bajorek E, Black S, Branscomb E, Caenepeel S, Carrano A, Caoile C, Chan YM, Christensen M, Cleland CA, Copeland A, Dalin E, Dehal P, Denys M, Detter JC, Escobar J, Flowers D, Fotopulos D: The DNA sequence and biology of human chromosome 19. Nature. 2004, 428: 529-35. 10.1038/nature02399.

    Article  CAS  PubMed  Google Scholar 

  29. Chiu W-W, Kinney RM, Dreher TW: Control of translation by the 5’- and 3'-terminal regions of the dengue virus genome. J Virol. 2005, 79: 8303-15. 10.1128/JVI.79.13.8303-8315.2005.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  30. Traherne JA: Human MHC architecture and evolution: implications for disease association studies. Int J Immunogenetics. 2008, 35: 179-92. 10.1111/j.1744-313X.2008.00765.x.

    Article  CAS  Google Scholar 

Download references

Acknowledgements

We thank Alvaro Martinez Barrio for critical reading and discussions, Leslie Gaffney for help with the figures, and UPPNEX/UPPMAX for providing computational resources.

Funding

This work was partly funded by a start-up grant from the Science for Life Laboratory (M.G.G), the Swedish research council FORMAS (P.J.), and by the National Human Genome Research Institute (Large Scale Sequencing and Analysis of Genomes, grant no. NIH 1 U54 HG03067, Lander); ESF EURYI award recipient (K.L.T.).

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Manfred G Grabherr.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors’ contributions

NZ, PR, NV, EM, and MGG implemented the software. PR provided the mathematical formulation. JRSM, PJ, HL, MPH, FdP, KLT, and MGG designed the dengue and primate experiments. NV designed and performed the simulations. PJ provided the biological interpretation for the dengue results. HL provided phylogenies. All authors wrote the manuscript and designed the figures. All authors read and approved the final manuscript.

Neda Zamani, Pamela Russell, Henrik Lantz, Marc P Hoeppner, Jennifer RS Meadows contributed equally to this work.

Authors’ original submitted files for images

Rights and permissions

Open Access This article is published under license to BioMed Central Ltd. This is an Open Access article is distributed under the terms of the Creative Commons Attribution License ( https://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

Zamani, N., Russell, P., Lantz, H. et al. Unsupervised genome-wide recognition of local relationship patterns. BMC Genomics 14, 347 (2013). https://doi.org/10.1186/1471-2164-14-347

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2164-14-347

Keywords