Skip to main content

Reference-free phylogeny from sequencing data

Abstract

Motivation

Clustering of genetic sequences is one of the key parts of bioinformatics analyses. Resulting phylogenetic trees are beneficial for solving many research questions, including tracing the history of species, studying migration in the past, or tracing a source of a virus outbreak. At the same time, biologists provide more data in the raw form of reads or only on contig-level assembly. Therefore, tools that are able to process those data without supervision need to be developed.

Results

In this paper, we present a tool for reference-free phylogeny capable of handling data where no mature-level assembly is available. The tool allows distance calculation for raw reads, contigs, and the combination of the latter. The tool provides an estimation of the Levenshtein distance between the sequences, which in turn estimates the number of mutations between the organisms. Compared to the previous research, the novelty of the method lies in a newly proposed combination of the read and contig measures, a new method for read-contig mapping, and an efficient embedding of contigs.

Peer Review reports

Introduction

The genetic code includes not only information about current organisms and their state, but it also contains enough information to trace the history of evolution. With phylogenetic trees that represent hypothetical evolutionary trees, one can, for example, trace the migration in the Middle East area [10], find a source of a virus outbreak [9], or solve a hundred-year-old argument between biologists, on the one hand claiming that a panda is a bear and biologists, on the other hand classifying panda as a raccoon [22].

Historically, biologists had to rely on phenotype to build such a tree. With advances in genome sequencing, DNA—the genuine source of differences between species—is used instead. Given a set of DNA sequences, their pairwise similarities can be computed through sequence alignment, enabling a subsequent construction of a phylogenetic tree through a hierarchical clustering algorithm.

However, obtaining the needed sequences from biological material is not straightforward. The DNA molecule is first cloned and cut into many short fragments. Then, we select fragments of a similar length, which are sequenced in parallel. The sequenced fragments are called reads and the read length length is usually between tens to hundreds of nucleotides. Since the read positions in the sequence are unknown, the in-silico assembly of the original sequence is based on detected overlaps between input read pairs. Typically, the sequence cannot be reconstructed entirely due to a part of it not being covered by enough reads, the presence of long repeat regions, or other reasons. As a result, instead of the original sequence, the algorithm produces a set of sequence’s non-overlapping substrings called contigs.

Additional wet-lab sequencing work is needed to move from contigs toward the target sequence. Usually, so-called mate-paired reads are sequenced. Those are two reads sequenced from the ends of a fragment of a known length. For some mate-pairs, the sequenced ends of the fragments can hopefully be located in two different contigs, which allows building a scaffold to order contigs and estimate gaps between them. Then a computationally expensive iterative procedure called gap-filling tries to align reads to the ends of the contigs to extend them.

The mentioned sequencing issues are avoided by the alignment-free approaches (AF) [39] that estimate the similarities from constant-length subsequences, called k-mers, which the input sequences are broken into. This principle naturally allows using raw reads on the input. The main advantage of the AF approaches is that they are, by order of magnitude, faster than the conventional sequence alignment methods [39]. A disadvantage is the obvious loss of information incurred by the breakage into k-mers. Indeed, the most promising area for the alignment-based approaches is when the alignment is applied to short, mutually similar sequences [39].

With decreasing costs of genome sequencing, more and more data are being produced, and researchers commonly publish their data in the form of read sets accompanied by their partial assemblies, i.e., with a set of contigs. Here we contribute a method and a tool suitable for said kind of input data leveraging the assembled contigs but also all leftover reads not included in the contigs.

The method combines the advantages of conventional and AF approaches. The method allows distance estimation without the need to determine the complete sequences or to break the already assembled contigs into k-mers. Instead, the k-mers are used only to select prospective reads and contigs to apply alignment calculation on. In this way, the distance is evaluated on closely matching regions of the sequences. The proposed method does not assume the availability of any reference genome. By avoiding de novo assembly, the method requires smaller coverage than the conventional assemble-then-align approach. Compared to the AF methods, the proposed method has a more straightforward connection to the evolutionary distance between the organisms as its goal is to estimate directly the number of point mutations that occurred between the species over time. While the presented approach is slower than the AF methods, the distances calculated by our method are closer to the reference solutions, and the results are usable in more cases.

This study uses some ingredients from our previous work. In particular, we follow up on the method [26, 28] that assumed the inputs to consist exclusively of reads and another one assuming only contigs on the input [27]. In contrast to these previous studies, the present proposal exploits both kinds of inputs synergically. The sequence similarity computation is based on matching reads and contigs from the two input sequences yielding four different matching cases. For read-read matching, we use the algorithm from [26]. For contig-contig matching, we adopt and improve the method [27]. The original method featured favorable accuracies of the computed estimates; however, the quadratic time complexity hindered its practical use. Here we provide an improvement of the technique achieving a speedup by order of one or two magnitudes without significant influence on the quality of the estimates (Efficient contig-contig matching section). Read-to-contig and contig-to-reads matching strategies are novel contributions of this paper (Read-contig mapping, Contig-reads mapping, and Efficient read-contig matching sections).

The salient contribution of this paper is the integration of the four mentioned facets to provide the desired distance estimate (Avoiding redundancy and Combination of the measures sections). We present a robust method that leverages the assembled contigs of the input sequences, but when such contigs are not available, or they cover only a small part of the sequences, the method maintains good accuracy due to its ability to exploit raw reads as well.

Problem formalization

Here we formalize the problem tackled in the rest of the paper. Table 1 summarizes the notation of the main concepts.

A string is a sequence of symbols chosen from \(\{\mathsf{a,g,c,t}\}\). As we will not be concerned with sequences other than strings, the words string and sequence will be used interchangeably. The empty string is denoted as \(\varepsilon\), |x| means the length of string x, and xy is the concatenation of strings x and y. If \(x=ps\), then p is a prefix of string x, and s is a suffix of it. If \(x=pys\), then (ps) is an occurrence of string y in string x. String y is a substring of string x if there is an occurrence of y in x. Two strings overlap if a non-empty prefix of one is a suffix of the other one. Two substrings xy of z overlap in z if there exist strings uvw such that v is not empty, uvw is a substring of z, and \(x=uv, y=vw\) or \(y=uv\), \(x=vw\). So, e.g., \(\mathsf{ct}\) and \(\mathsf{tg}\) overlap in \(\mathsf{ctg}\) but not in \(\mathsf{ctatg}\).

Given a set of strings \(S = \{s_1, s_2, \ldots , s_n\}\), string s is a superstring of S if all \(s_i\) (\(1 \le i \le n\)) are substrings of s, and given also \(K \in \mathbb {N}\), we define the bounded superstring problem followingly: is there a superstring s of S such that \(|s| \le K\)? This problem is NP-hard [8].

Read a of sequence A is a short (\(|a| \ll |A|\)) substring of A. Read bag \(R_{A}\) of A is a bag of reads of constant length \(l \in \mathbb {N}\) sampled i.i.d. with replacement from the uniform distribution on all possible \(|A| - l - 1\) substrings of A of length l. Coverage

$$\begin{aligned} c = \frac{l|R_{A}|}{|A|} \end{aligned}$$
(1)

indicates the average number of reads covering a particular position in A. Here, we assume a constant coverage for all read bags considered.

Contig \(\alpha\) of sequence A is a substring of A, and contig set \(C_{A}\) of A is a set of contigs of A such that no two contigs in \(C_{A}\) overlap in A.Footnote 1

The sequence assembly task is to reconstruct sequence A from its read bag \(R_{A}\). This general task statement does not allow any guarantees for an exact solution; one cannot be, for example, sure that reads in \(R_{A}\) cover all positions in A. Typically, a surrogate problem is, therefore, considered instead: find the shortest superstring of \(R_{A}\). While this formulation has a well-defined solution, it is, of course, at least as hard as the bounded superstring problem and, thus, NP-hard. As such, it is usually tackled in a heuristic manner by the iterative merging of overlapping read pairs, generally resulting in multiple mutually disconnected assembled sequences (contigs) and a bag of remaining reads not used in the contigs.Footnote 2

Let \(\mathsf{dist}(A, B)\) denote the Levenshtein distance [16] between sequences A and B, i.e., the minimum number of operations insert, delete, and substitute needed to make the two sequences the same.Footnote 3

Table 1 An overview of the notation used in the paper

The task we deal with in this paper is to estimate \(\mathsf{dist}(A, B)\) given contig set \(C_{A}\) and read bag \(R_{A}\) of A, and the analogical inputs \(C_{B}, R_{B}\) for B. Again, stated this way, the problem does not provide any guarantees for the exact solution for reasons including incomplete coverage by reads, but also the fact that the sum of lengths of the input contigs may be larger than the original sequence length. Analogically to the sequence assembly task, we consider instead a surrogate problem defined in turn.

Given two contig sets, \(C_{A}, C_{B}\), and two read bags, \(R_{A}, R_{B}\), the partially assembled sequences distance problem (PASDP) is to determine \(\mathsf{dist}(\tilde{A}, \tilde{B})\) where \(\tilde{A}\) (\(\tilde{B}\), respectively) is the shortest superstring of \(R_{A} \cup C_{A}\) (\(R_{B} \cup C_{B}\)).

We now show that PASDP is NP-hard. Let (SK) be an instance of the bounded superstring problem. We will show that it reduces to PASDP. Let \(C_{A} = C_{B} = \emptyset\). Let \(R_{A} = S\) and \(R_{B} = \emptyset\). Then \(\tilde{B} = \varepsilon\) and \(\tilde{A}\) is the shortest superstring of S. As \(\tilde{B}\) is empty, by the definition of the Levenshtein distance,

$$\begin{aligned} \mathsf{dist}(\tilde{A}, \tilde{B}) = | \tilde{A} | = | \text {shortest superstring of}\ S|. \end{aligned}$$
(2)

The bounded superstring problem is answered positively if and only if \(\mathsf{dist}(\tilde{A}, \tilde{B}) \le K\). Therefore, PASDP is at least as hard as the bounded superstring problem and thus is indeed NP-hard.

Related work

This research relates to alignment-free measures (AF measures). For sequence A, we can define the q-gram profile as vector \(\textbf{Q}^{A}_{k}\) whose i-th component is equal to the number of occurrences of the i-th q-gramFootnote 4 in A. The first AF measure, \(D_2\), was proposed by [4] as simply the scalar product of \(\textbf{Q}^{A}_{k}\) and \(\textbf{Q}_{k}^{B}\). Many other measures followed, including, \(D_2^S\), D2z, [13, 25], differing mostly only in normalization or bias removal to capture the real nature of the data. A recent overview of the AF methods is in [39].

We will compare our approach with two state-of-the-art algorithms namely co-phylog [37], and Mash [23].

The co-phylog algorithm introduces a notation of C-gram subsequences. Each C-gram has one or more positions called O-grams. On C-gram positions, an exact match is required. On O-gram positions, any nucleotide is acceptable. For both sequences, a mapping is created from C-grams to corresponding O-grams. This mapping is then used to calculate the distance as similar sequences have a higher number of shared C-gram-O-gram pairs.

The Mash algorithm is based on the hashing approach used originally for embedding. In its nature, Mash is very similar to the \(D_2\) measure. For each k-mer of the sequence, its hash is calculated. It is not guaranteed that two distinct k-mers have different hashes; however, this situation is not very likely-the algorithm then computes the Jaccard index of the set of hashes. The main advantage of the algorithm compared to the \(D_2\) measure is its effectiveness, as it is much easier to store the set of hashes in the memory than the whole set of k-mers.

The success of the alignment-free tools justifies the need for alignment-free and assembly-free tools. Review paper [39] mentioned more than 100 tools published in 2017. The Mash tool meanwhile collected more than 1, 000 citations according to the publisher’s website.

Proposed method

The non-tractability of PASDP motivates a heuristic approach to compute a sub-optimal solution. To this end, we avoid any attempts to reconstruct A and B from the input reads and contigs, as these inputs are already assumed to be the ultimate outputs of an assembly algorithm so further overlap-based assembly is futile.

To estimate the distance between the sequences, we will be matching strings (reads and contigs) from one sequence with those of the other. Each such match will yield a contribution to the final distance (dissimilarity function). We follow the “Occam’s razor” heuristic that for a string from one sequence, we should look for the closest match in the other sequence to yield the distance contribution. This rationale is supported by the fact that if the original sequences were known, their dissimilarity would be computed under their best possible alignment.

The matching strategy differs for the four possible pairing sorts (refer to Fig. 1): read-to-read, read-to-contig, contig to one or more reads, and contig to one or more contigs. This section details them individually and also describes how the matching results integrate into the final distance estimate. Fig. 2 reveals the data flow among the methodological components.

Fig. 1
figure 1

An overview of possible mappings between reads and contigs. A read can map either to a read (, [28]) or a contig (, Read-contig mapping section). Similarly, a contig can map to a part of another contig (, [27]) or multiple reads (, Contig-reads mapping section). Reads that were assembled to a contig do not need to be considered (, Avoiding redundancy section)

Fig. 2
figure 2

An overview of the algorithm with references to the corresponding sections and equations

Contig-contig mapping

Here we explain how we match two contigs by identifying a substring in each of them such that the two substrings have a small Levenshtein distance and also are sufficiently long. Then we elaborate on a matching between a contig and a contig set based on a dynamic programming procedure using the results of the contig-contig matches. Finally, we define the match between two contig sets.

There are two ways in which two contigs can be matched: 1) one is an (approximate) substring of the other, or 2) the two (approximately) overlap. We seek a match that is as long as possible, and at the same time, the distance of the matched parts should be as small as possible. This results in the minimization of the post-normalized Levenshtein distance, which is the ratio of the Levenshtein distance and the maximum of the sequence lengths. Formally, we define the match of two contigs \(\alpha \in C_{A}, \beta \in C_{B}\) as

$$\begin{aligned} \mathsf{match}(\alpha ,\beta ) = \underset{(\alpha ^{*},\beta ^{*}) \in S(\alpha ,\beta )}{\mathsf {arg\,min}} \frac{\mathsf{dist}(\alpha ^{*},\beta ^{*})}{\max \{ |\alpha ^{*}|, |\beta ^{*}| \}}, \end{aligned}$$
(3)

where

$$\begin{aligned} S(\alpha , \beta ) = \mathsf{suff}(\alpha ) \times \mathsf{pref}(\beta ) \cup \mathsf{pref}(\alpha ) \times \mathsf{suff}(\beta ) \cup \mathsf{sub}(\alpha ) \times \{ \beta \} \cup \{ \alpha \} \times \mathsf{sub}(\beta ). \end{aligned}$$
(4)

By symbols \(\mathsf{pref}\), \(\mathsf{suff}\), and \(\mathsf{sub}\), we mean the set of all non-empty prefixes, suffixes, and substrings, respectively. To avoid small random overlaps, a thresholdFootnote 5 of 20 is applied on lengths \(|\alpha ^{*}|, |\beta ^{*}|\).

For each contig \(\alpha \in C_{A}\), we can calculate the match with each contig in \(C_{B}\). As contigs represent non-overlapping subsequences of the genome, each symbol of \(\alpha\) should be mapped to at most one contig from \(C_{B}\). For each \(\alpha\), we thus identify a set of contigs in \(C_{B}\) that satisfies the said condition. This is achieved by a reduction to the weighted interval scheduling problem [14]. The latter is solved by an efficient dynamic-programming procedure (see [27] for details) and yields an admissible subset of matches for contig \(\alpha\):

$$\begin{aligned} \mathsf{match}(\alpha , C_{B}) \subseteq \{ \mathsf{match}(\alpha , \beta ) \mid \beta \in C_{B} \}. \end{aligned}$$
(5)

Next, we define the set of all admissible matches for \(C_{A}\):

$$\begin{aligned} \mathsf{match}(C_{A}, C_{B}) = \bigcup _{\alpha \in C_{A}} \mathsf{match}(\alpha , C_{B}). \end{aligned}$$
(6)

To calculate the distance between \(C_{A}\) and \(C_{B}\), we sum the distances of the string pairs in \(\mathsf{match}(C_{A}, C_{B})\) (the nominator in (7)). Because the overlap lengths do not necessarily correlate with sequence lengths, the measure is normalizedFootnote 6 (the denominator in Eq. (7)):

$$\begin{aligned} \mathsf{dist}_{\mathsf{C}}(C_{A}, C_{B}) = \frac{\sum _{(\alpha ^{*},\beta ^{*}) \in \mathsf{match}(C_{A}, C_{B})} \mathsf{dist}(\alpha ^{*},\beta ^{*})}{\sum _{(\alpha ^{*},\beta ^{*}) \in \mathsf{match}(C_{A}, C_{B})} \max \{ |\alpha ^{*}|, |\beta ^{*}|\}} . \end{aligned}$$
(7)

Avoiding redundancy

Before we start with mapping reads to contigs, we need to filter out duplicate information. There are two reasons for that — runtime and the aim to avoid bias caused by reusing some parts of sequences twice. Firstly, contigs are generated from reads. There is no need to find matches for a read assembled into a contig since we already found a match for the contig.

To avoid this duplicate work, we re-define

$$\begin{aligned} R_{A}' \leftarrow R_{A} \setminus \{ i \in R_{A} \mid i\ \text {is a substring of some}\ \alpha \in C_{A} \}. \end{aligned}$$
(8)

To eliminate the reads that are substrings of a contig, we use the Aho-Corasick algorithm [2], which builds an automaton on reads in \(R_{A}\) and finds their occurrences in a single linear pass through a contig.

Secondly, if a part of contig \(\alpha \in C_{A}\) is matched with another contig in \(C_{B}\), we do not need to match it with reads in \(R_{B}\) — we know that the counterparts are already in \(C_{B}\). Instead of \(C_{A}\), we work further with \(C_{A}'\) that contains for all \(\alpha\) only substrings of \(\alpha\) that are not in \(\mathsf{match}(\alpha , C_{B})\). In other words, let \(\mathsf{match}(\alpha , C_{B}) = \{ (\alpha ^{*}_1, \beta _1), (\alpha ^{*}_2, \beta _2), \ldots , (\alpha ^{*}_n, \beta _n) \}\), let \(\alpha = \alpha _0' \alpha ^{*}_1 \alpha _1' \alpha ^{*}_2 \alpha _2' \cdots \alpha ^{*}_n \alpha _n'\), and let

$$\begin{aligned} \overline{\mathsf{match}}(\alpha , C_{B}) = \{ \alpha _0', \alpha _1', \alpha _2' \ldots \alpha _n' \} \end{aligned}$$

be a set of all substrings of \(\alpha\) that are not matched to any contig in \(C_{B}\). Then,

$$\begin{aligned} C_{A}' = \bigcup _{\alpha \in C_{A}} \overline{\mathsf{match}}(\alpha , C_{B}). \end{aligned}$$
(9)

Read-read mapping

We adopt the method from [28] based on the Monge-Elkan distance [18] to establish the distance function for two read bags. It follows the same spirit as above; in particular, each read a in \(R_{A}\) is matched with the closest read in \(R_{B}\). Formally, the Monge-Elkan distance is defined as

$$\begin{aligned} \underset{\mathsf{ME}}{\mathsf{dist}} (R_{A}, R_{B}) = \frac{1}{|R_{A}|} \sum _{a \in R_{A}} \min _{b \in R_{B}} \mathsf{dist}_{\mathsf{rr}} (a, b) . \end{aligned}$$
(10)

The read-read distance \(\mathsf{dist}_{\mathsf{rr}}\) above is essentially the Levenshtein distance except for the following adjustment. Because read locations are random, the first \(t = \frac{1}{2} \left( \frac{l}{c} - 1 \right)\) leading or trailing gaps are not penalized in the alignment of two reads.Footnote 7

The range of \(\mathsf{dist}_{\mathsf{ME}}\) is [0; l] as the function is the average of values in the said interval. On the contrary, the Levenshtein distance is in the range of \([0; \max \{|A|, |B|\}]\). In the experiments, we will use the scaled symmetric version of the distance, denoted \(\mathsf{dist}_{\mathsf{MESSG}}\).

Read-contig mapping

When aligning a read to a contig, the read can either overlap with one of the contig ends, or it can match a substring of the contig. Therefore, the match for the read can be defined as a substring of \(\beta\) that has the lowest distance from a but for borders where the first t margin gaps are not penalized. Otherwise, the read-contig distance is defined as

$$\begin{aligned} \mathsf{dist}_{\mathsf{rc}}(a, \beta ) = \min _{\begin{array}{c} i \in [2, |\beta |-l-2], \\ j \in [i+1, |\beta |-l-1] \end{array}} \mathsf{dist}(a, \beta _i^{j}), \end{aligned}$$
(11)

where \(\beta _i^{j}\) denotes a substring of \(\beta\) that starts at i and ends at j.

Following the reasoning from Read-read mapping section, it is not desirable to penalize leading or trailing gaps up to a certain length at contig ends. Therefore, we modify the Wagner-Fischer dynamic programming algorithm [34] so that it does not penalize the first t leading or trailing gaps caused by a random location of the read or different lengths of the contig and the read. The cost function used for the margin gap penalty is illustrated in Fig. 3.

Fig. 3
figure 3

An illustration to (11). Instead of constant 1 (dashed line), the gap extension penalty on margins changes to the solid line. In this case, the cost-free margin gaps are t = 2  

Contig-reads mapping

Here, the mapping is very similar to the one used in the previous section. There is, however, a slight difference — contig \(\alpha\) is long, and as a result, there should be multiple reads \(b \in R_{B}\) that map to \(\alpha\). By (1), there should be \(|\alpha | \cdot c / l\) reads on average. Therefore, we calculate the \(\mathsf{dist}_{\mathsf{rc}}\) distance from \(\alpha\) to all \(b \in R_{B}\) and select the \(|\alpha | \cdot c / l\) minimum distances.

From Avoiding redundancy section, we know that we will use only unmatched substrings \(\alpha '\). Therefore, we define dissimilarity for \(\alpha '\) as

$$\begin{aligned} \underset{\mathsf{cR}}{\mathsf{dist}}(\alpha ', R_{B}) = \min _{\left\{ S \subseteq R_{B}' \left| |S| = \left\lfloor \frac{|\alpha '| \cdot c}{l} \right\rfloor \right. \right\} }\sum _{b \in S} \mathsf{dist}_{\mathsf{rc}} (b, \alpha '). \end{aligned}$$
(12)

The formula above selects subset S of read bag \(R_{B}'\) that minimizes the sum of the distances between the reads and \(\alpha '\).

Combination of the measures

The final measure based on reads follows Eq. (10). For each read \(a' \in R_{A}'\), there should be exactly one match — either a read or a contig. We define the distance from a read to the closest read or contig as

$$\begin{aligned} \underset{\mathsf{rT}}{\mathsf{dist}}(a', T_{B}) = \min \left\{ \min _{b' \in R_{B}'} \mathsf{dist}_{\mathsf{rr}}(a', b'), \min _{\beta \in C_{B}} \mathsf{dist}_{\mathsf{rc}}(a', \beta ) \right\} . \end{aligned}$$
(13)

The sum of (13) and (12) over all reads and contigs gives a pre-measure that contains all information captured in reads as

$$\begin{aligned} \mathsf{dist}_{\mathsf{TT}\backslash \mathsf{R}}(T_{A}, T_{B}) = \frac{\displaystyle \sum _{a' \in R_{A}'} \mathsf{dist}_{\mathsf{rT}}(a', T_{B}) + \sum _{\alpha ' \in C_{A}'} \mathsf{dist}_{\mathsf{cR}}(\alpha ', R_{B})}{l \left( |R_{A}'| + \sum _{\alpha ' \in C_{A}'} \left\lfloor \frac{|\alpha '| \cdot c}{l} \right\rfloor \right) }. \end{aligned}$$
(14)

The denominator in Eq. (14) scales to [0, 1] interval and is calculated by substituting l for distance calculations.

In the next step, we will have to combine \(\mathsf{dist}_{\mathsf{TT}\backslash \mathsf{R}}(T_{A}, T_{B})\) with the measure capturing the distance between the contigs. To do so, we use a weighted average based on the part of the original sequences covered by the contigs. \(\mathsf{dist}_{\mathsf{C}}(C_{A}, C_{B})\) uses only a part of sequence A, namely

$$\begin{aligned} |\mathsf{match}|(C_{A}, C_{B}) = \sum _{(\alpha ^{*}, \cdot ) \in \mathsf{match}(C_{A}, C_{B})} |\alpha ^{*}|. \end{aligned}$$

On the contrary, the estimate of A length is \(|R_{A}| \cdot l / c\). The weight assigned to the contig-contig measure is, therefore,

$$\begin{aligned} w = \min \left\{ 1, |\mathsf{match}|(C_{A}, C_{B}) \cdot \frac{c}{|R_{A}| l}\right\} . \end{aligned}$$
(15)

The \(\min\) operation is to prevent errors of assembly because there is no guarantee that the contigs will be shorter than the true sequence. We define pre-distance as

$$\begin{aligned} \mathsf{dist}_{\mathsf{TT}}(T_{A}, T_{B}) = w \mathsf{dist}_{\mathsf{C}}(C_{A}, C_{B}) + (1-w) \mathsf{dist}_{\mathsf{TT}\backslash \mathsf{R}}(T_{A}, T_{B}) . \end{aligned}$$
(16)

The final distance is the scaled (see Formula (1) — \(\mathsf{dist}_{\mathsf{TT}}\) is from the [0, 1] interval while \(\mathsf{dist}(A, B)\) is from the \([0, \max \{|A|, |B|\}]\) interval) symmetric version

$$\begin{aligned} {\mathsf{dist}}(T_{A}, T_{B}) = \frac{\mathsf{dist}_{\mathsf{TT}}(T_{A}, T_{B}) + \mathsf{dist}_{\mathsf{TT}}(T_{B}, T_{A})}{2} \cdot \frac{l \cdot \max \{|R_{A}|, |R_{B}|\}}{c} . \end{aligned}$$
(17)

Efficiency improvements

Equation (17) gives a way to compute the distance. However, this method is too slow for practical use as it requires the alignment of all data in \(T_{A}\) and \(T_{B}\). Most of those alignments are, however, not necessary as they do not count towards the minimum in (5), (10), and (12). Therefore, we will use only a carefully selected subset of alignments, as illustrated in Fig. 4. Following [26], we use the technique of embedding reads to q-grams to filter out alignments that won’t count towards the output of the \(\min\) operator. Recall the q-gram profile \(\textbf{Q}^{A}_{k}\) of a string A defined in Related work section. The q-gram distance of A and B, denoted \(\mathsf{dist}_q (A,B)\), is the Manhattan distance of q-gram profiles of A and B, i.e., \(\mathsf{dist}_q(A,B) = \Vert \textbf{Q}^{A}_{k} - \textbf{Q}_{k}^{B} \Vert _1\).

Fig. 4
figure 4

The main idea of the efficiency improvements in Efficiency improvements section. Instead of pairwise alignment of all reads and contigs vs. all reads and contigs, we run the exact quadratic alignment only for a small subset of those. This subset of candidates is identified based on the q-gram distance, which runs in linear time. See Fig. 1 for meaning of the caption numbers

Informally, the q-gram distance counts how many substrings of length q are in one sequence and not in the other (or vice versa). The q-gram distance is a simple but effective approximation of the Levenshtein distance [33] as it holds that

$$\begin{aligned} \mathsf{dist} (A, B) \ge \frac{1}{2q} \cdot \mathsf{dist}_q (A, B). \end{aligned}$$
(18)

While we need \(\mathcal {O}(|A||B|)\) time to calculate the Levenshtein distance, the q-gram distance is much faster to compute: we need \(\mathcal {O}(q + |A| + |B|) + 4^q)\) or only \(\mathcal {O}(4^{q})\) if we precompute the q-gram profiles in advance.

Efficient read-read matching

Calculating the edit distance between two reads with the Wagner-Fischer algorithm [34] (called Needleman-Wunsch [20] in the bioinformatics context) is very fast as reads are usually only hundreds of symbols long. However, the Monge-Elkan distance requires us to calculate the distance between all pairs of reads. We, however, need only the closest match in Eq. (10). Therefore, as a heuristic, we select a candidate for the match (there may be more of them than one) under the q-gram distance for each read. Because of the typical read length, we use \(q=3\). Once having only a few closest match candidates, we can calculate the exact Levenshtein distance.

Efficient read-contig matching

Matching a read to a contig means finding the contig’s substring, which is the most similar to the read. Instead of the quadratic dynamic programming approach, we can exploit the q-gram distance and find a set of candidates in linear time. Then for this short substring, we can call the exact quadratic alignment.

A naive implementation of the search under the q-gram distance requires a quadratic amount of work. This can be cut down to linear time using the sliding window method. Once we have calculated the q-gram distance for a prefix of length l of the contig, we can only update the distance by observing the first-to-add q-gram of the contig and the last-to-remove q-gram of the contig. Once we have the correct candidates, we trigger the exact quadratic alignment.

Efficient contig-contig matching

We relax the matching problem by positing the following assumption. Referring to (3), we assume that for \((\alpha ^{*}, \beta ^{*}) = \mathsf{match}(\alpha , \beta )\), it holds that \(|\alpha ^{*}| = |\beta ^{*}|\). This reduces the quadratic number of possible overlap candidates to a linear number.

We adapt the sliding window approach from the previous section that updates the current distance only by two q-grams as contigs slide one against each other. This allows us to find a match candidate that minimizes the ratio of the q-gram distance over the length of the match. Once having this candidate, we can calculate the exact Levenshtein distance of the matching contig parts faster using Ukkonen’s cutoff heuristic from [32] and [3].

We now address the choice of q. In the two preceding sections, we compared sequences of fixed length l. Here, the overlap length grows up to the minimum of the contig lengths. According to study [19], the q-gram distance works well for sequences of length \(4^q\). With longer sequences, the q-gram profiles start to get closer to a fixed distribution (uniform for random sequences). To avoid this bias towards the long overlaps, we need to switch between q values as overlaps get longer. For a value of q, we consider overlaps of length from the interval \([4^{q-1}, 4^{q+1}]\). However, direct comparison is still not possible, as our goal is to minimize the Levenshtein distance. Instead of comparing the ratio of \(\mathsf{dist}_q\) over the overlap length, we divide this ratio by q, which is a direct result of (18).

Experiments

To evaluate the method, we run the algorithm on several real-world and simulated datasets. The simulated data will allow us to study the method under a wide range of coverage and read length, which is not available for real-world data.

Tested algorithms

The tested algorithms can be divided into several groups. The first group includes trivial baselines that should illustrate the complexity of the problem. This includes \(\max \{|R_{A}|, |R_{B}|\}\), a simple upper bound on the Levenshtein distance, and the Levenshtein distance between the two longest contigs as produced by an assembly algorithm. Next, the comparison includes our previous work (distances \(\mathsf{dist}_{MESSG}\) [28], \(\mathsf{dist}_{MESSGq}\) [26], \(\mathsf{dist}_{\mathsf{C}}\) [27]), the newly proposed method \(\mathsf{dist}\) (as of Eq. (17)), and \(\mathsf{dist}_q\) (with improvements from Efficiency improvements section, alternatively including downsampling denoted by \(\alpha\) index). The state-of-the-art alignment-free approaches include Mash [23], d-type measures [5], and co-phylog [37]. The alignment-free approaches were initialized with the default set of parameters, and the d-type measures used \(k=5\). The alignment-free measures used only reads as input.

Any time contigs were used as an input in one of the methods, we used contigs calculated from the aforementioned read bags together with five assembly algorithms, namely ABySS [30], Edena [11], SPADES [21], SSAKE [35], and Velvet [38]. All assembly algorithms were initialized with the default parameters whenever possible.

Used datasets

The influenza dataset consists of 13 real-world virus DNA sequences. Reads from those sequences are then sampled uniformly under the i.i.d. assumption. The sampling of reads was done for 20 coverage values in a range from 0.1 to 100. We used 14 read length values in a range from 3 to 500. The original sequences were used as a reference for distance calculation using the Wagner-Fischer algorithm [34]. The sequences were downloaded from the ENA repository [15] and were selected to contain similar virus genomes. The various dataset contains sequences of different viruses and undergoes the same procedure. The hepatitis dataset contains 81 hepatitis sequences. This time, the read sampling was done with the ART program [12] for \((\alpha , l) \in \{10, 30, 50\} \times \{30, 70, 100\}\).

We use two real-world datasets. The first one contains sequences that are supposed to be completely different. We selected \(20\,\text {kbp}\) regions from the human DNA, each region from the beginning of one chromosome (excluding telomeres). For those regions, we selected reads that map to those regions. The reads come from the 1000 genome project [1]. The second real-world dataset, the e-coli dataset, contains 15 bacterial DNA of the same species. In this case, no official assembly for each of the read bags exists; therefore, we compare the algorithms in quantitative measures that do not need assembly.

Evaluation criteria

We evaluate the method in both qualitative as well as quantitative measures. The qualitative measures are represented by Pearson’s correlation coefficient and the Fowlkes-Mallows index [7]. The first measure compares the similarity of the distance matrices by calculating the correlation coefficient on the distances to the reference distances calculated from the original sequences using the Wagner-Fischer algorithm [34].

The Fowlkes-Mallows index \(B_k\) is used to compare the resulting phylogenetic trees built by the neighbor-joining algorithm [29]. To calculate \(B_k\), the tree is cut at level k to obtain several clusters. For the tested method and the reference, the clusterings are then compared. Besides the Fowlkes-Mallows index, the second method used to compare the trees is the triplets distance [6]. The distance counts how many times a set of three organisms form a tree of different topology.

The quantitative measures compare how well the method performs in terms of time and how often the method produces a valid result (for low coverage, an assembly algorithm may fail to produce any contigs, disqualifying all methods that depend only on contigs or calculation tool longer than the time limit of two hours (1 day on the hepatitis dataset)). Besides the finished cases, we measure the assembly time and the distance matrix time separately.

Table 2 Summary of the results. The finished column shows how many times the distance calculation was successful for different choices of read length and correlation. The following columns contain average assembly time, distance matrix calculation time, Pearson’s correlation coefficient of distance matrices, the Fowlkes-Mallows index for \(k=4\) and \(k=8\), and the triplets distance. Note that the triplets distance is calculated only on a sample of read length and coverage values on the influenza and various datasets. The averaged results are only for the situations when the method finished. The rank columns show the average rank of the methods in distance calculation time and correlation, including the situations when the method did not finish. The ‘reference’ method calculates distances of the original sequences. We show only assembly algorithms that gave the highest and the lowest correlation. From d-type measures, the one with the highest correlation is selected. For an explanation of the rank column, see Evaluation criteria section
Table 3 Pairwise correlations of distance matrices on “E. coli” dataset. The last two columns show the runtime on the “E. coli” dataset. Assembly time (without distance matrix calculation) on the same dataset is \(24{,}980\,\textrm{s}\) (ABySS), \(17{,}514\,\textrm{s}\) (Edena), \(1021{,}184\,\textrm{s}\) (SPAdes), \(229{,}350\,\textrm{s}\) (SSAKE), and \(17{,}608\,\textrm{s}\) (Velvet). See the Supplementary materials for results of all tested methods

Results averaging

The influenza and various datasets contain reads for many coverages and read length values. This high range of coverage and read length was selected to show the behavior of the methods in extreme cases, for example in Fig. 5. For each coverage value (read length, respectively), we averaged the results. As extreme read length and coverage values are undesirable and likely to cause outliers, whenever we present an average, the average is calculated excluding the three most outlying values of read length (coverage). In such a case, the coverage spanned between 0.7 and 40, and the read length was between 15 and 100.

Fig. 5
figure 5

Plot of the average Pearson’s correlation coefficient for several choices of coverage (top plot) and read length (bottom plot) on the influenza dataset. See the Supplementary materials for the results on the various dataset

For both distance calculation time and Pearson’s correlation coefficient, we provide the average rank of the methods. This is because the time and correlation are hard to interpret, together with information on whether each algorithm calculated valid results within the time limit. Therefore, we sorted the results for each choice of coverage and read length, placing the methods that did not finish last together with the case when the correlation was not defined (i.e., all sequences were equidistant). Then the rank is defined as the number of better methods in the sorted list plus one. The rank was then averaged over coverage and read length values, as explained earlier.

Discussion

The main experimental results can be seen in Table 2. Besides that, Fig. 5 shows the dependency of the correlation between the reference and the predicted distances on read length and coverage. Table 3 shows experimental results on the e-coli dataset. Fig. 6 shows how the Fowlkes-Mallows index depends on the depth in the phylogenetic tree.

Fig. 6
figure 6

Plot of dependence of quality of the phylogenetic tree on depth in the tree. To calculate the Fowlkes-Mallows index \(B_k\), the tree is cut at level k and the clusterings are compared

The results shown in Table 2 indicate that method \(\mathsf{dist}_q\) including the efficiency optimizations from Efficiency improvements section, yields valid results in a broader range of cases than other methods. Compared to the alignment-free approaches, the method works well on both similar as well as dissimilar genomes, while the performance of the alignment-free approaches is worse on dissimilar genomes. Fig. 5 further illustrates that the method is capable of producing reasonable results for low-coverage data and very short reads.

Table 2 shows that compared to the previous versions of the method, the newly proposed changes are faster. However, the method is, as expected, slower than the alignment-free methods. Compared to the assembly time, there were differences in the order of magnitude. However, it needs to be said that the assembly algorithms were used with default parameters, which allowed parallel computation by default. If we look at the E.coli dataset in Table 3, we see that the single-threaded implementation is comparable to the assembly time and by the order of magnitude faster than assembly in the parallel version. Table 3 also shows that on 32 cores system, the speedup reached is more than 20 times.

Concerning the correlation, the method performs better on one dataset and worse on one dataset than our previous research. Compared to the alignment-free methods, the proposed method did better on two datasets while worse on one dataset.

The proposed changes improve the runtime up to three magnitudes. Note that in the case of the hepatitis dataset, the exact variant of the contig-based method finishes only in two cases, while the faster variant finishes in all cases.

The real-world experiments show that our method is successful in approximating the Levenshtein distance between the compared sequences. The experiments show that the method requires coverage of 2. Potential benefits, therefore, include a possible reduction of the wet lab sequencing, no need to use high coverages or to sequence mate pairs. The method is applicable to viral genomes or shorter bacteria genomes. Figure 5 has also shown that the correlation is high for read length of 10. This might be useful in some applications; for example, publication [17] justifies the need to use assembly-free, alignment-free, and reference-free tools by MiSeq [24] sequencing of rapidly mutating RNA viruses. Nevertheless, Fig. 5 shows that the possible conditions when our method works are much wider.

Our methods had two assumptions. The first one was that the read length l is the same for all reads. This can be justified by the fact that many of the sequencing technologies (including Illumina) read in each iteration a single nucleotide. As a result, all reads are sequenced with the same read length. The assumption that the coverage is equal for all samples is usually not met. Hence, in our publicly available implementation, this requirement is not enforced and can be replaced by either providing per-read-bag coverage or estimating the lengths of each genome. For our analyses, especially in the artificial datasets, we assumed that the reads are generated uniformly, which is usually not exactly true [36].

Conclusion

We have presented a method capable of calculating sequence distances for inducing phylogenetic trees from reads and/or contigs of the input sequences. The method works universally for a wide range of coverage, read length, and similar and dissimilar organisms. Compared to the alignment-free approaches, the method turned out slower but performed better in terms of the correlation of the computed distance matrix with the ground truth. Also, the new method has a more straightforward interpretation in terms of the number of mutations needed to transform one genome into another.

Availability of data and materials

Source codes and a pre-compiled version of the method are available on https://github.com/petrrysavy/reference-free-phylogeny.

Notes

  1. We adopt the assumption of contigs not overlapping in the original sequence from [31].

  2. The resulting contigs and leftover reads may be concatenated in arbitrary order to produce the requested single superstring, which—due to the heuristic nature of the algorithm—is not necessarily the shortest.

  3. Under the molecular clock hypothesis, this function indicates the least possible number of mutations, which, in turn, approximates the evolutionary distance.

  4. The q-gram and k-mer represent the same thing — a substring of length q (k).

  5. This number approximately matches free gap parameter t (which will be introduced in Read-read mapping section) for most common read length \(l=100\) and coverage between 2 and 3.

  6. Note that this function has the range [0, 1] while the unknown distance between A and B is in the range \([0, \max \{|A|, |B|\}]\); we will address the scale in a later step in Eq. (17).

  7. See [28] for the derivation of the value assigned to t.

References

  1. \(1000\) Genomes Project Consortium, et al. A global reference for human genetic variation. Nature. 2015;526(7571):68–74. https://doi.org/10.1038/nature15393.

  2. Aho AV, Corasick MJ. Efficient String Matching: An Aid to Bibliographic Search. Commun ACM. 1975;18(6):333–40. https://doi.org/10.1145/360825.360855.

    Article  Google Scholar 

  3. Berghel H, Roach D. An Extension of Ukkonen’s Enhanced Dynamic Programming ASM Algorithm. ACM Trans Inf Syst. 1996;14(1):94–106. https://doi.org/10.1145/214174.214183.

    Article  Google Scholar 

  4. Blaisdell BE. A measure of the similarity of sets of sequences not requiring sequence alignment. Proc Natl Acad Sci. 1986;83(14):5155–9.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  5. Comin M, Schimd M. Assembly-Free Techniques for NGS Data. In: Elloumi M, editor. Algorithms for Next-Generation Sequencing Data: Techniques, Approaches, and Applications. Cham: Springer; 2017. p. 327–55. https://doi.org/10.1007/978-3-319-59826-0_14.

    Chapter  Google Scholar 

  6. Critchlow DE, Pearl DK, Qian C. The Triples Distance for Rooted Bifurcating Phylogenetic Trees. Syst Biol. 1996;45(3):323–34. https://doi.org/10.1093/sysbio/45.3.323.

    Article  Google Scholar 

  7. Fowlkes EB, Mallows CL. A Method for Comparing Two Hierarchical Clusterings. J Am Stat Assoc. 1983;78(383):553–69. https://doi.org/10.1080/01621459.1983.10478008.

    Article  Google Scholar 

  8. Gallant J, Maier D, Astorer J. On finding minimal length superstrings. J Comput Syst Sci. 1980;20(1):50–8. https://doi.org/10.1016/0022-0000(80)90004-5.

    Article  Google Scholar 

  9. Gire SK, Goba A, et al. Genomic surveillance elucidates Ebola virus origin and transmission during the 2014 outbreak. Science. 2014;345(6202):1369–72. https://doi.org/10.1126/science.1259657.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  10. Haber M, Doumet-Serhal C, et al. Continuity and Admixture in the Last Five Millennia of Levantine History from Ancient Canaanite and Present-Day Lebanese Genome Sequences. Am J Hum Genet. 2017;101(2):274–82. https://doi.org/10.1016/j.ajhg.2017.06.013.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  11. Hernandez D, François P, Farinelli L, Østerås M, Schrenzel J. De novo bacterial genome sequencing: Millions of very short reads assembled on a desktop computer. Genome Res. 2008;18(5):802–9. https://doi.org/10.1101/gr.072033.107.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  12. Huang W, Li L, et al. ART: a next-generation sequencing read simulator. Bioinformatics. 2012;28(4):593–4. https://doi.org/10.1093/bioinformatics/btr708.

    Article  CAS  PubMed  Google Scholar 

  13. Kantorovitz MR, Robinson GE, Sinha S. A statistical method for alignment-free comparison of regulatory sequences. Bioinformatics. 2007;23(13):i249–55. https://doi.org/10.1093/bioinformatics/btm211.

    Article  CAS  PubMed  Google Scholar 

  14. Kleinberg J, Tardos E. Algorithm Design. Boston: Addison-Wesley Longman Publishing Co., Inc.; 2005.

    Google Scholar 

  15. Leinonen R, Akhtar R, Birney E, et al. The European Nucleotide Archive. Nucleic Acids Res. 2011;39(suppl-1):D28–31. https://doi.org/10.1093/nar/gkq967.

    Article  CAS  PubMed  Google Scholar 

  16. Levenshtein VI. Binary codes capable of correcting deletions, insertions, and reversals. Soviet Phys Dokl. 1966;10(8):707.

    Google Scholar 

  17. Melnyk A, Knyazev S, Vannberg F, Bunimovich L, Skums P, Zelikovsky A. Using earth mover’s distance for viral outbreak investigations. BMC Genomics. 2020;21(5):582. https://doi.org/10.1186/s12864-020-06982-4.

    Article  PubMed  PubMed Central  Google Scholar 

  18. Monge AE, Elkan CP. The Field Matching Problem: Algorithms and Applications. KDD’96. Portland: AAAI Press; 1996. p. 267–70.

    Google Scholar 

  19. Navarro G. A Guided Tour to Approximate String Matching. ACM Comput Surv. 2001;33(1):31–88. https://doi.org/10.1145/375360.375365.

    Article  Google Scholar 

  20. Needleman SB, Wunsch CD. A general method applicable to the search for similarities in the amino acid sequence of two proteins. J Mol Biol. 1970;48(3):443–53. https://doi.org/10.1016/0022-2836(70)90057-4.

    Article  CAS  PubMed  Google Scholar 

  21. Nurk S, Bankevich A, et al. Assembling Genomes and Mini-metagenomes from Highly Chimeric Reads. In: Deng M, Jiang R, Sun F, Zhang X, editors. Research in Computational Molecular Biology: 17th Annual International Conference, RECOMB 2013, Beijing, China, April 7-10, 2013. Proceedings. Berlin: Springer Berlin Heidelberg; 2013. p. 158–70. https://doi.org/10.1007/978-3-642-37195-0_13.

    Chapter  Google Scholar 

  22. O’Brien SJ, Nash WG, et al. A molecular solution to the riddle of the giant panda’s phylogeny. Nature. 1985;317:140–4. https://doi.org/10.1038/317140a0.

    Article  PubMed  Google Scholar 

  23. Ondov BD, Treangen TJ, et al. Mash: fast genome and metagenome distance estimation using MinHash. Genome Biol. 2016;17(1):132. https://doi.org/10.1186/s13059-016-0997-x.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  24. Ravi RK, Walton K, Khosroheidari M. MiSeq: A Next Generation Sequencing Platform for Genomic Analysis. New York: Springer New York; 2018. p. 223–32. https://doi.org/10.1007/978-1-4939-7471-9_12.

    Book  Google Scholar 

  25. Reinert G, Chew D, Sun F, Waterman MS. Alignment-free sequence comparison (I): statistics and power. J Comput Biol. 2009;16(12):1615–34. https://doi.org/10.1089/cmb.2009.0198.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  26. Ryšavý P, Železný F. Estimating sequence similarity from read sets for clustering next-generation sequencing data. Data Min Knowl Discov. 2019;33(1):1–23. https://doi.org/10.1007/s10618-018-0584-8.

    Article  Google Scholar 

  27. Ryšavý P, Železný F, et al. Estimating Sequence Similarity from Contig Sets. In: Adams N, et al., editors. Advances in Intelligent Data Analysis XVI. Cham: Springer; 2017. p. 272–83. https://doi.org/10.1007/978-3-319-68765-0_23.

    Chapter  Google Scholar 

  28. Ryšavý P, Železný F. Estimating Sequence Similarity from Read Sets for Clustering Sequencing Data. In: Boström H, et al., editors. Advances in Intelligent Data Analysis XV. Cham: Springer; 2016. p. 204–214. (BEST PAPER AWARD). https://doi.org/10.1007/978-3-319-46349-0_18.

  29. Saitou N, Nei M. The neighbor-joining method: a new method for reconstructing phylogenetic trees. Mol Biol Evol. 1987;4(4):406–25. https://doi.org/10.1093/oxfordjournals.molbev.a040454.

    Article  CAS  PubMed  Google Scholar 

  30. Simpson JT, Wong K, Jackman SD, Schein JE, Jones SJM, Birol İ. ABySS: A parallel assembler for short read sequence data. Genome Res. 2009;19(6):1117–23. https://doi.org/10.1101/gr.089532.108.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  31. Staden R. A mew computer method for the storage and manipulation of DNA gel reading data. Nucleic Acids Res. 1980;8(16):3673–94. https://doi.org/10.1093/nar/8.16.3673.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  32. Ukkonen E. Algorithms for approximate string matching. Inf Control. 1985;64(1):100–18. https://doi.org/10.1016/S0019-9958(85)80046-2.

    Article  Google Scholar 

  33. Ukkonen E. Approximate string-matching with q-grams and maximal matches. Theor Comput Sci. 1992;92(1):191–211. https://doi.org/10.1016/0304-3975(92)90143-4.

    Article  Google Scholar 

  34. Wagner RA, Fischer MJ. The String-to-String Correction Problem. J Assoc Comput Mach. 1974;21(1):168–73. https://doi.org/10.1145/321796.321811.

    Article  Google Scholar 

  35. Warren RL, Sutton GG, Jones SJM, Holt RA. Assembling millions of short DNA sequences using SSAKE. Bioinformatics. 2007;23(4):500–1. https://doi.org/10.1093/bioinformatics/btl629.

    Article  CAS  PubMed  Google Scholar 

  36. Wu Z, Wang X, Zhang X. Using non-uniform read distribution models to improve isoform expression inference in RNA-Seq. Bioinformatics. 2010;27(4):502–8. https://doi.org/10.1093/bioinformatics/btq696.

    Article  CAS  PubMed  Google Scholar 

  37. Yi H, Jin L. Co-phylog: an assembly-free phylogenomic approach for closely related organisms. Nucleic Acids Res. 2013;41(7):e75. https://doi.org/10.1093/nar/gkt003.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  38. Zerbino DR, Birney E. Velvet: Algorithms for de novo short read assembly using de Bruijn graphs. Genome Res. 2008;18(5):821–9. https://doi.org/10.1101/gr.074492.107.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  39. Zielezinski A, Vinga S, Almeida J, Karlowski WM. Alignment-free sequence comparison: benefits, applications, and tools. Genome Biol. 2017;18(1):186. https://doi.org/10.1186/s13059-017-1319-7.

    Article  PubMed  PubMed Central  Google Scholar 

Download references

Acknowledgements

The authors acknowledge the support of the OP VVV project CZ.02.1.01/0.0/0.0/16_019/0000765 “Research Center for Informatics”.

Author information

Authors and Affiliations

Authors

Contributions

PR and FŽ worked on the design of the method. PR did implementation and prepared the initial version of the manuscript. FŽ contributed to the final version of the manuscript.

Corresponding author

Correspondence to Petr Ryšavý.

Ethics declarations

Competing interests

The authors declare that they have no competing interests.

Additional information

Publisher’s Note

Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Supplementary Information

Rights and permissions

Open Access This article is licensed under a Creative Commons Attribution 4.0 International License, which permits use, sharing, adaptation, distribution and reproduction in any medium or format, as long as you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons licence, and indicate if changes were made. The images or other third party material in this article are included in the article's Creative Commons licence, unless indicated otherwise in a credit line to the material. If material is not included in the article's Creative Commons licence and your intended use is not permitted by statutory regulation or exceeds the permitted use, you will need to obtain permission directly from the copyright holder. To view a copy of this licence, visit http://creativecommons.org/licenses/by/4.0/. The Creative Commons Public Domain Dedication waiver (http://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated in a credit line to the data.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Ryšavý, P., Železný, F. Reference-free phylogeny from sequencing data. BioData Mining 16, 13 (2023). https://doi.org/10.1186/s13040-023-00329-x

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s13040-023-00329-x

Keywords