Skip to main content

Fast algorithms for approximate circular string matching

Abstract

Background

Circular string matching is a problem which naturally arises in many biological contexts. It consists in finding all occurrences of the rotations of a pattern of length m in a text of length n. There exist optimal average-case algorithms for exact circular string matching. Approximate circular string matching is a rather undeveloped area.

Results

In this article, we present a suboptimal average-case algorithm for exact circular string matching requiring time

O(n)

. Based on our solution for the exact case, we present two fast average-case algorithms for approximate circular string matching with k-mismatches, under the Hamming distance model, requiring time

O(n)

for moderate values of k, that is

k=O(m/logm)

. We show how the same results can be easily obtained under the edit distance model. The presented algorithms are also implemented as library functions. Experimental results demonstrate that the functions provided in this library accelerate the computations by more than three orders of magnitude compared to a naïve approach.

Conclusions

We present two fast average-case algorithms for approximate circular string matching with k-mismatches; and show that they also perform very well in practice. The importance of our contribution is underlined by the fact that the provided functions may be seamlessly integrated into any biological pipeline. The source code of the library is freely available at http://www.inf.kcl.ac.uk/research/projects/asmf/.

Background

Circular sequences appear in a number of biological contexts. This type of structure occurs in the DNA of viruses [1, 2], bacteria [3], eukaryotic cells [4], and archaea [5]. In [6], it was noted that, due to this, algorithms on circular strings may be important in the analysis of organisms with such structure. Circular strings have previously been studied in the context of sequence alignment. In [7], basic algorithms for pairwise and multiple circular sequence alignment were presented. These results were later improved in [8], where an additional preprocessing stage was added to speed up the execution time of the algorithm. In [9], the authors also presented efficient algorithms for finding the optimal alignment and consensus sequence of circular sequences under the Hamming distance metric.

In order to provide an overview of our results and algorithms, we begin with a few definitions, generally following [10]. We think of a string x of length n as an array x[ 0..n−1], where every x[ i], 0≤i<n, is a letter drawn from some fixed alphabet Σ of size σ=|Σ|. The empty string of length 0 is denoted by ε. A string x is a factor of a string y if there exist two strings u and v, such that y=u x v. Let the strings x,y,u, and v be such that y=u x v. If u=ε, then x is a prefix of y. If v=ε, then x is a suffix of y.

Let x be a non-empty string of length n and y be a string. We say that there exists an occurrence of x in y, or, more simply, that x occurs in y, when x is a factor of y. Every occurrence of x can be characterised by a position in y. Thus we say that x occurs at the starting position i in y when y[ i..i+n−1]=x. The Hamming distance between strings x and y, both of length n, is the number of positions i, 0≤i<n, such that x[ i]≠y[ i]. Given a nonnegative integer k, we write x k y if the Hamming distance between x and y is at most k.

A circular string of length n can be viewed as a traditional linear string which has the left- and right-most symbols wrapped around and stuck together in some way. Under this notion, the same circular string can be seen as n different linear strings, which would all be considered equivalent. Given a string x of length n, we denote by xi=x[ i..n−1]x[0..i−1], 0<i<n, the i-th rotation of x and x0=x. Consider, for instance, the string x=x0=abababbc; this string has the following rotations: x1=bababbca, x2=ababbcab, x3=babbcaba, x4=abbcabab, x5=bbcababa, x6=bcababab, x7=cabababb.

Here we consider the problem of finding occurrences of a pattern string x of length m with circular structure in a text string t of length n with linear structure. For instance, the DNA sequence of many viruses has circular structure, so if a biologist wishes to find occurrences of a particular virus in a carriers DNA sequence—which may not be circular—they must consider how to locate all positions in t that at least one rotation of x occurs. This is the problem of circular string matching.

The problem of exact circular string matching has been considered in [11], where an O(n)-time algorithm was presented. A naïve solution with quadratic complexity consists in applying a classical algorithm for searching a finite set of strings after having built the trie of rotations of x. The approach presented in [11] consists in preprocessing x by constructing a suffix automaton of the string xx, by noting that every rotation of x is a factor of xx. Then, by feeding t into the automaton, the lengths of the longest factors of xx occurring in t can be found by the links followed in the automaton in time O(n). In [12], the authors presented an optimal average-case algorithm for exact circular string matching, by also showing that the average-case lower bound for single string matching of O(n log σ m/m) also holds for circular string matching. Very recently, in [13], the authors presented two fast average-case algorithms based on word-level parallelism. The first algorithm requires average-case time O(n log σ m/w), where w is the number of bits in the computer word. The second one is based on a mixture of word-level parallelism and q-grams. The authors showed that with the addition of q-grams, and by setting q=O( log σ m), an optimal average-case time of O(n log σ m/m) is achieved. Indexing circular patterns [14] and variations of approximate circular string matching under the edit distance model [15]—both based on the construction of a suffix tree—have also been considered.

In this article, we consider the following problems.

Problem 1 (Exact Circular String Matching).

Given a pattern x of length m and a text t of length n>m, find all factors u of t such that u=xi, 0≤i<m.

Problem

2 (Approximate Circular String Matching with k-Mismatches).

Given a pattern x of length m, a text t of length n>m, and an integer threshold k<m, find all factors u of t such that u k xi, 0≤i<m.

The aforementioned algorithms for the exact case exhibit the following disadvantages: first, they cannot be applied in a biological context since both single nucleotide polymorphisms as well as errors introduced by wet-lab sequencing platforms might have occurred in the sequences; second, it is not clear whether they could easily be adapted to deal with the approximate case. Similar to the exact case [12], it can be shown that the average-case lower bound for single approximate string matching of O(n(k+ log σ m)/m)[16] also holds for approximate circular string matching with k-mismatches under the Hamming distance model. To the best of our knowledge, no optimal average-case algorithm exists for this problem. Therefore, to achieve optimality, one could use the optimal average-case algorithm for multiple approximate string matching, presented in [17], for matching the r=m rotations of x requiring, on average, time O(n(k+ log σ rm)/m), only if k/m<1/2O(1/ σ ), r=O(min( n 1 / 3 / m 2 , σ o ( m ) )), and we have O( m 4 r 2 σ O ( 1 ) ) space available; which is impractical for large m: e.g. the genome of the smallest known viruses replicating autonomously in eukaryotic cells is around 1.8 KB long. The authors propose solutions to reduce the required space, however using various space–time trade-off techniques.

Our Contribution. We present a new suboptimal average-case algorithm for exact circular string matching requiring time O(n). Although suboptimal, this algorithm can be easily extended to tackle the approximate case efficiently. Based on our solution for the exact case, we present two new fast average-case algorithms for approximate circular string matching with k-mismatches, under the Hamming distance model, requiring time O(n) for moderate values of k, that is k=O(m/ log σ m). The first algorithm requires space O(n) and the second one O(m). We show how the same results can be easily obtained under the edit distance model. The presented algorithms are also implemented as library functions. Experimental results demonstrate that the functions provided in this library accelerate the computations by more than three orders of magnitude compared to a naïve approach. The source code of the library is freely available at http://www.inf.kcl.ac.uk/research/projects/asmf/.

Properties of the partitioning technique

In this section, we give a brief outline of the partitioning technique in general; and then show some properties of the version of the technique we use for our algorithms. The partitioning technique, introduced in [18], and in some sense earlier in [19], is an algorithm based on filtering out candidate positions that could never give a solution to speed up string-matching algorithms. An important point to note about this technique is that it reduces the search space but does not, by design, verify potential occurrences. To create a string-matching algorithm filtering must be combined with some verification technique. The idea behind the partitioning technique was initially proposed for approximate string matching, but here we show that this can also be used for exact circular string matching.

The idea behind the partitioning technique is to partition the given pattern in such a way that at least one of the fragments must occur exactly in any valid approximate occurrence of the pattern. It is then possible to search for these fragments exactly to give a set of candidate occurrences of the pattern. It is then left to the verification portion of the algorithm to check if these are valid approximate occurrences of the pattern. It has been experimentally shown that this approach yields very good practical performance on large-scale datasets [20], even if it is not theoretically optimal.

For exact circular string matching, for an efficient solution, we cannot simply apply well-known exact string-matching algorithms, as we must also take into account the rotations of the pattern. We can, however, make use of the partitioning technique and, by choosing an appropriate number of fragments, ensure that at least one fragment must occur in any valid exact occurrence of a rotation. Lemma 1 together with the following fact provide this number.

Fact

1. Any rotation of x=x[ 0..m−1] is a factor of x=x[ 0..m−1]x[ 0..m−2]; and any factor of length m of x is a rotation of x.

Lemma

1. If we partition x=x[ 0..m−1]x[ 0.. m−2] in 4 fragments of length (2m−1)/4 and (2m−1)/4, at least one of the 4 fragments is a factor of any factor of length m of x.

Proof.

Let f denote the length of the fragment. If we partition x in at least 4 fragments of length (2m−1)/4 and (2m−1)/4, we have that

f ( 2 m 1 ) / 4 ,

which gives 2m>4 f and m>2 f . Therefore any factor of length m of x, and, by Fact 1, any rotation of x, must contain at least one of the fragments. For a graphical illustration of this proof inspect Figure 1. ■

Figure 1
figure 1

Lemma 1. Illustration of Lemma 1.

Lemma

2. Let x and y=y0y1y k be two strings, both of length n, such that y0,y1,…,y k are k+1≤n non-empty strings and x k y. Then there exists at least one string y i , 0≤ik, starting at position j of y, 0≤j<n, occurring at the starting position j of x.

Proof. Immediate from the pigeonhole principle—if n items are put into m<n pigeonholes, then at least one pigeonhole must contain more than one item. ■

Based on Lemma 2, we take a similar approach to the one described by Lemma 1, to obtain the sufficient number of fragments in the case of approximate circular string matching with k-mismatches.

Lemma

3. If we partition x=x[ 0.. m−1]x[ 0.. m−2] in 2k+4 fragments of length (2m−1)/(2k+4) and (2m−1)/(2k+4), at least k+1 of the 2k+4 fragments are factors of any factor of length m of x.

Proof. Let f denote the length of the fragment. If we partition x in 2k+4 fragments of length (2m−1)/(2k+4) and (2m−1)/(2k+4), we have that

f ( 2 m 1 ) / ( 2 k + 4 ) ,

which gives 2m−1≥2(k+2) f and m>(k+2) f . Therefore any factor of length m of x, and, by Fact 1, any rotation of x, must contain at least k+1 of the fragments. For a graphical illustration of this proof inspect Figure 2. ■

Figure 2
figure 2

Lemma 3. Illustration of Lemma 3.

Exact circular string matching via filtering

In this section, we present ECSMF, a new suboptimal average-case algorithm for exact circular string matching via filtering. It is based on the partitioning technique and a series of practical and well-established data structures such as the suffix array (for more details see [21]).

Longest common extension

First, we describe how to compute the longest common extension, denoted by lce, of two suffixes of a string in constant time (for more details see [22]). lce queries are an important part of the algorithms presented later on.

Let SA denote the array of positions of the sorted suffixes of string x of length n, i.e. for all 1≤r<n, we have x[ SA[ r−1]..n−1]<x[ SA[ r]..n−1]. The inverse iSA of the array SA is defined by iSA[ SA[ r]]=r, for all 0≤r<n. Let lcp(r,s) denote the length of the longest common prefix of the strings x[ SA[ r].. n−1] and x[ SA[ s].. n−1], for all 0≤r,s<n, and 0 otherwise. Let LCP denote the array defined by LCP[ r]=lcp(r−1,r), for all 1<r<n, and LCP[ 0]=0. We perform the following linear-time and linear-space preprocessing:

  • Compute arrays SA and iSA of x[21].

  • Compute array LCP of x[23].

  • Preprocess array LCP for range minimum queries, we denote this by RMQLCP[24].

With the preprocessing complete, the lce of two suffixes of x starting at positions p and q can be computed in constant time in the following way [22]:

LCE ( x , p , q ) = LCP [ RMQ LCP ( iSA [ p ] + 1 , iSA [ q ] ) ] .

Example

1. Let the string x =abbababba. The following table illustrates the arrays SA, iSA, and LCP for x.

We have LCE(x,1,2)=LCP[ RMQLCP(iSA[ 2]+1,iSA[ 1])]=LCP[ RMQLCP(6,8)]=1, implying that the lce of bbababba and bababba is 1.

Algorithm ECSMF

Given a pattern x of length m and a text t of length n>m, an outline of algorithm ECSMF for solving Problem 1 is as follows.

  1. 1.

    Construct the string x =x[ 0.. m−1]x[ 0.. m−2] of length 2m−1. By Fact 1, any rotation of x is a factor of x .

  2. 2.

    The pattern x is partitioned in 4 fragments of length (2m−1)/4 and (2m−1)/4. By Lemma 1, at least one of the 4 fragments is a factor of any rotation of x.

  3. 3.

    Match the 4 fragments against the text t using an Aho Corasick automaton [25]. Let be a list of size Occ of tuples, where < p x ,, p t > is a 3-tuple such that 0 p x <2m1 is the position where the fragment occurs in x , is the length of the corresponding fragment, and 0≤p t <n is the position where the fragment occurs in t.

  4. 4.

    Compute SA, iSA, LCP, and RMQLCP of T=x t. Compute SA, iSA, LCP, and RMQLCP of T r =rev(t x ), that is the reverse string of t x .

  5. 5.

    For each tuple < p x ,, p t >, we try to extend to the right via computing

    E r LCE ( T , p x + , 2 m 1 + p t + ) ;

    in other words, we compute the length E r of the longest common prefix of x [ p x +..2m1] and t[ p t +.. n−1], both being suffixes of T. Similarly, we try to extend to the left via computing E l using lce queries on the suffixes of T r .

  6. 6.

    For each E l , E r computed for tuple < p x ,, p t >, we report all the valid starting positions in t by first checking if the total length E l ++ E r m; that is the length of the full extension of the fragment is greater than or equal to m, matching at least one rotation of x. If that is the case, then we report positions

    max { p t E , p t + m } , , min { p t + m + E r , p t } .

Example 2.

Let the pattern x=GGGTCTA of length m=7, and the text t=GATACGATACCTAGGGTGATAGAATAG. Then x=GGGTCTAGGGTCT (Step 1). x is partitioned in GGGT, CTA, GGG, and TCT (Step 2). Consider <4,3,10>, that is, fragment x[ 4..6]=CTA, of length =3, occurs at starting position p t =10 in t (Step 3). Then T=GGGTCTAGGGTCTGATACGATACCTAGGGTGATAGAATAG and T r =TCTGGGATCTGGGGATAAGATAGTGGGATCCATAGCATAG (Step 4). Extending to the left gives E l =0, since T r [ 9]≠T r [ 30]; and extending to the right gives E r =4, since T[ 7..10]=T[ 26..29] and T[ 11]≠T[ 30] (Step 5). We check that E l ++ E r =7=m, and therefore we report position 10 (Step 6):

p t E = 10 0 = 10 , , p t + m + E r = 10 + 3 7 + 4 = 10 ;

that is, x4=CTAGGGT occurs at starting position 10 in t.

Theorem

1. Given a pattern x of length m drawn from alphabet Σ, σ=|Σ|, and a text t of length n>m drawn from Σ, algorithm ECSMF requires average-case time O(n) to solve Problem 1.

Proof.

Constructing and partitioning the string x from x can trivially be done in time O(m) (Step 1-2). Building the Aho-Corasick automaton of the 4 fragments requires time O(m); and the search time is O(n+Occ) (Step 3) [25]. The preprocessing step for the lce queries on the suffixes of T and T r can be done in time O(n) (Step 4). Computing E l and E r for each occurrence of a fragment requires time O(Occ) (Step 5). For each extended occurrence of a fragment, we report O(m) valid starting positions, thus O(mOcc) in total (Step 6). Since the expected number Occ of occurrences of the 4 fragments in t is 4n/ σ ( 2 m 1 ) / 4 =O( n σ 2 m 1 4 ), algorithm ECSMF requires average-case time O((1+ m σ 2 m 1 4 )n). It achieves average-case time O(n)iff

f = 4 m σ 2 m 1 4 n cn

for some fixed constant c. For σ=2, the maximum value of f is attained at

m = 2 / ln 2 2.8853

and so for σ>1 we get

4 m σ 2 m 1 4 n 5.05 n.

Approximate circular string matching with k-mismatches via filtering

In this section, based on the ideas presented in algorithm ECSMF, we present algorithms ACSMF and ACSMF-Simple, two new fast average-case algorithms for approximate circular string matching with k-mismatches via filtering.

Algorithm ACSMF

The first four steps of algorithm ACSMF are essentially the same as in algorithm ECSMF. A small difference exists in Step 2, where the sufficient number of fragments in the case of approximate circular string matching with k-mismatches is used. The main difference is in Step 5, where algorithm ACSMF tries to extend k+1 times to the right and k+1 times to the left. Given a pattern x of length m, a text t of length n>m, and an integer threshold k<m, an outline of algorithm ACSMF for solving Problem 2 is as follows.

  1. 1.

    Construct the string x =x[ 0.. m−1]x[0.. m−2] of length 2m−1. By Fact 1, any rotation of x is a factor of x .

  2. 2.

    The pattern x is partitioned in 2k+4 fragments of length (2m−1)/(2k+4) and (2m−1)/(2k+4). By Lemma 3, at least k+1 of the 2k+4 fragments are factors of any rotation of x.

  3. 3.

    Match the 2k+4 fragments against the text t using an Aho Corasick automaton [25]. Let be a list of size Occ of tuples, where < p x ,, p t > is a 3-tuple such that 0 p x <2m1 is the position where the fragment occurs in x , is the length of the corresponding fragment, and 0≤p t <n is the position where the fragment occurs in t.

  4. 4.

    Compute SA, iSA, LCP, and RMQLCP of T=x t. Compute SA, iSA, LCP, and RMQLCP of T r =rev(t x ), that is the reverse string of t x .

  5. 5.

    For each tuple < p x ,, p t >, we try to extend k+1 times to the right via computing

    E r 0 LCE ( T , p x + , 2 m 1 + p t + ) + 1
    E r 1 LCE ( T , p x + + E r 0 , 2 m 1 + p t + + E r 0 ) + 1
    E r k 1 LCE ( T , p x + + E r k 2 , 2 m 1 + p t + + E r k 2 ) + 1
    E r k LCE ( T , p x + + E r k 1 , 2 m 1 + p t + + E r k 1 ) ;

    in other words, we compute the length E r k of the longest common prefix of x [ p x +..2m1] and t[ p t +.. n−1], both being suffixes of T, with k mismatches. Similarly, we try to extend to the left k+1 times via computing E l k using lce queries on the suffixes of T r .

  6. 6.

    For each tuple < p x ,, p t > we try to extend, we also maintain an array M of size 2m−1, initialised with zeros, where we mark the position of the i-th left and right mismatch, 1≤ik, by setting

    M [ p x E l i 1 1 ] 1 and M [ p x + + E r i 1 ] 1 .
  7. 7.

    For each E l k , E r k ,M computed for tuple < p x ,, p t >, we report all the valid starting positions in t by first checking if the total length E l k ++ E r k m; that is the length of the full extension of the fragment is greater than or equal to m. If that is the case, then we count the total number of mismatches of the occurrences at starting positions

    max { p t E k , p t + m } , , min { p t + m + E r k , p t } ,

    by first summing up the mismatches for the leftmost starting position

    μ j M [ p x E l k ] + + M [ p x E l k + m 1 ] ,
    where j = max { p t E k , p t + m } .

For each subsequent position j+1, we subtract the value of the leftmost element of M computed for μ j and add the value of the next element to compute μj+1. In case μ j k, we report position j.

Example

3. Let the pattern x =GGGTCTA of length m=7, the text t = GATACGATACCTAGGGTGATAGAATAG, and k =1. Then x = GGGTCTAGGGTCT (Step 1). x is partitioned in GGG, TC, TA, GG, GT, and CT (Step 2). Consider <9,2,15>, that is, fragment x[ 9.. 10]=GT, of length = 2, occurs at starting position p t =15 in t (Step 3). Then T =GGGTCTAGGGTCTGATACGATACCTAGGGTGATAGAATAG and T r =TCTGGGATCTGGGGATAAGATAGTGGGATCCATAGCATAG (Step 4). Extending to the left gives E l k =6, since T r [ 4.. 9]≡ k T r [ 25.. 30] and T r [ 10]≠T r [ 31]; and extending to the right gives E r k =1, since T[ 11]≡ k T[ 30] and T[ 12]≠T [ 31] (Step 5). We also set M[ 3]=1 and M[ 11]=1 (Step 6). We check that E l ++ E r =9>m, and therefore we report positions 10, since i = 4 10 M[i]=0<k, and 11, since i = 5 11 M[i]=1=k (Step 7):

p t + m = 15 + 2 7 = 10 , , p t + m + E r = 15 + 2 7 + 1 = 11 ;

that is, x 4 =CTAGGGT and x 5 =TAGGGTC occur at starting position 10 in t with no mismatch and at starting position 11 in t with 1 mismatch, respectively.

Theorem

2. Given a pattern x of length m drawn from alphabet Σ, σ=|Σ|, a text t of length n>m drawn from Σ, and an integer threshold k<m, algorithm ACSMF requires average-case time O((1+ km σ 2 m 1 2 k + 4 )n) and space O(n) to solve Problem 2.

Proof.

Constructing and partitioning the string x from x can trivially be done in time O(m) (Step 1-2). Building the Aho-Corasick automaton of the 2k+4 fragments requires time O(m); and the search time is O(n+Occ) (Step 3) [25]. The preprocessing step for the lce queries on the suffixes of T and T r can be done in time and space O(n) (Step 4)—see Section 3. Computing E l k and E r k for each occurrence of a fragment requires time O(kOcc) (Step 5)—see Section 3. Maintaining array M is of no extra cost (Step 6). For each extended occurrence of a fragment, we report O(m) valid starting positions, thus O(mOcc) in total (Step 7). Since the expected number Occ of occurrences of the 2k+4 fragments is (2k+4)n/ σ ( 2 m 1 ) / ( 2 k + 4 ) =O( kn σ 2 m 1 2 k + 4 ), algorithm ACSMF requires average-case time O((1+ km σ 2 m 1 2 k + 4 )n) and space O(n). ■

Corollary

1. Given a pattern x of length m drawn from alphabet Σ, σ=|Σ|, a text t of length n>m drawn from Σ, and an integer threshold k=O(m/ log σ m), algorithm ACSMF requires average-case time O(n).

Proof. Algorithm ACSMF achieves average-case time O(n)iff

m ( 2 k + 4 ) n / σ ( 2 m 1 ) / ( 2 k + 4 ) cn

for some fixed constant c. Let r=(2m−1)/(2k+4). We have

m ( 2 k + 4 ) n / σ r cn.

Since k<m, we can (pessimistically) replace k by m−1. Then we have

2 m ( m + 1 ) n / σ r cn.

Solving for r, and using k≤(2m−1)/2r−2, gives the maximum value of k, that is

k = O ( m / log σ m ) .

Algorithm ACSMF-simple

Algorithm ACSMF-simple is very similar to Algorithm ACSMF. The only differences are:

  • Algorithm ACSMF-simple does not perform Step 4 of Algorithm ACSMF;

  • For each tuple < p x ,, p t >, Step 5 of Algorithm ACSMF is performed without the use of the pre-computed indexes. In other words, we compute E r k and E k by simply performing letter comparisons and counting the number of mismatches occurred. The extension stops right before the k+1th mismatch.

Fact

2. The expected number of letter comparisons required for each extension in algorithm ACSMF-simple is less than 3.

Proof. Recall that on an alphabet of size σ, the probability that two random strings of length are equal is (1/σ). Thus, given two long strings, and setting r=1/σ, there is probability r that the initial letters are equal, r2 that the prefixes of length two are equal, and so on. Thus the expected number of positions to be matched before inequality occurs is

S = r + 2 r 2 + + ( n 1 ) r n 1 ,

for some n≥2. Hall & Knight [26, p. 44] tell us that

S = r ( 1 r n 1 ) / ( 1 r ) 2 ( n 1 ) r n / ( 1 r ) ,

which as n approaches r/(1−r)2<2 for all r. Thus S, the expected number of matching positions, is less than 2, and hence the expected number of letter comparisons required for each extension in algorithm ACSMF-Simple is less than 3. ■

Theorem

3. Given a pattern x of length m drawn from alphabet Σ, σ=|Σ|, a text t of length n>m drawn from Σ, and an integer threshold k<m, algorithm ACSMF-simple requires average-case time O((1+ km σ 2 m 1 2 k + 4 )n) and space O(m) to solve Problem 2.

Proof.

By Fact 2, computing E k and E r k for each occurrence of a fragment requires time O(kOcc). Therefore algorithm ACSMF-simple requires average-case time O((1+ km σ 2 m 1 2 k + 4 )n). The required space is reduced to O(m) since Step 4 of Algorithm ACSMF is not performed. ■

Corollary

2. Given a pattern x of length m drawn from alphabet Σ, σ=|Σ|, a text t of length n>m drawn from Σ, and an integer threshold k=O(m/ log σ m), algorithm ACSMF-simple requires average-case time O(n).

In practical cases, algorithm ACSMF-simple should be preferred over algorithm ACSMF as (i) it has less memory requirements (see Theorem 3); and (ii) it avoids the construction of a series of data structures (see Section 3 in this regard).

Edit distance model

Algorithm ACSMF-simple could be easily extended for approximate circular string matching under the edit distance model (for a definition, see [10]). Since each single-letter edit operation can change at most one of the 2k+4 fragments of x, any set of at most k edit operations leaves at least one of the fragments untouched. In other words, Lemma 2 holds under the edit distance model as well [27]. An area of length O(m) surrounding each potential occurrence found in the filtration phase (Steps 1-3 of algorithm ACSMF) is then searched using the standard dynamic-programming algorithm in time O( m 2 )[28] and space O(m)[29]. Since the expected number Occ of occurrences of the 2k+4 fragments is O( kn σ 2 m 1 2 k + 4 ), the average-case time complexity becomes O((1+ k m 2 σ 2 m 1 2 k + 4 )n) and the space complexity remains O(m). When k=O(m/ log σ m), the average-case time complexity is O(n).

Experimental results

We implemented algorithms ACSMF and ACSMF-Simple as library functions to perform approximate circular string matching with k-mismatches. The functions were implemented in the C programming language and developed under GNU/Linux operating system. They take as input arguments the pattern x of length m, the text t of length n, and the integer threshold k<m; and then return the list of starting positions of the occurrences of the rotations of x in t with k-mismatches as output. The library implementation is distributed under the GNU General Public License (GPL), and it is available at http://www.inf.kcl.ac.uk/research/projects/asmf/, which is set up for maintaining the source code and the man-page documentation. The experiments were conducted on a Desktop PC using one core of Intel i7 2600 CPU at 3.4 GHz under GNU/Linux.

Approximate circular string matching is a rather undeveloped area. To the best of our knowledge, there does not exist an optimal (average- or worst-case) algorithm for approximate circular string matching with k-mismatches. Therefore, keeping in mind that we wish to evaluate the efficiency of our algorithms in practical terms, we compared their performance to the respective performance of the C implementationa of the optimal average-case algorithm for multiple approximate string matching, presented in [17], for matching the r=m rotations of x. We denote this algorithm by FredNava.

Tables 1, 2, 3 illustrate elapsed-time and speed-up comparisons for various pattern sizes and moderate values of k, using a corpus of DNA data taken from the Pizza & Chili website [30]. As it is demonstrated by the experimental results, algorithm ACSMF-Simple is in all cases the fastest with a speed-up improvement of more than three orders of magnitude over FredNava. ACSMF is always the second fastest, while ACSMF-Simple still retains a speed-up improvement of more than one order of magnitude over ACSMF. Another important observation, also suggested by Corollaries 1 and 2, is that the ACSMF-based algorithms are essentially independent of m for moderate values of k.

Table 1 Elapsed-time and speed-up comparisons of FredNava , ACSMF , and ACSMF-Simple for n =1MB
Table 2 Elapsed-time and speed-up comparisons of ACSMF and ACSMF-Simple for n =10MB
Table 3 Elapsed-time and speed-up comparisons of ACSMF and ACSMF-Simple for n =50MB

Conclusions

In this article, we presented new average-case algorithms for exact and approximate circular string matching. Algorithm ECSMF for exact circular string matching requires average-case time O(n); and Algorithms ACSMF and ACSMF-simple for approximate circular string matching with k-mismatches require time O(n) for moderate values of k, that is k=O(m/ log σ m). We showed how the same results can be easily obtained under the edit distance model. The presented algorithms were also implemented as library functions. Experimental results demonstrate that the functions provided in this library accelerate the computations by more than three orders of magnitude compared to a naïve approach.

For future work, we will explore the possibility of optimising our algorithms and the corresponding library implementation for the approximate case by using lossless filters for eliminating a possibly large fraction of the input that is guaranteed not to contain any approximate occurrence, such as [31] for the Hamming distance model or [32] for the edit distance model. In addition, we will try to improve our algorithms for the approximate case in order to achieve average-case optimality.

Endnote

a Personal communication with author.

References

  1. Weil R, Vinograd J:The cyclic helix and cyclic coil forms of polyoma viral DNA. Proc Natl Acad Sci. 1963, 50 (4): 730-738.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  2. Dulbecco R, Vogt M:Evidence for a ring structure of polyoma virus DNA. Proc Natl Acad Sci. 1963, 50 (2): 236-243.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  3. Thanbichler M, Wang SC, Shapiro L:The bacterial nucleoid: A highly organized and dynamic structure. J Cell Biochem. 2005, 96 (3): 506-521. [http://dx.doi.org/10.1002/jcb.20519], []

    Article  CAS  PubMed  Google Scholar 

  4. Lipps G: Plasmids: Current Research and Future Trends. 2008, Norfolk, UK: Caister Academic Press.

    Google Scholar 

  5. Allers T, Mevarech M:Archaeal genetics — the third way. Nat Rev Genet. 2005, 6: 58-73.

    Article  CAS  PubMed  Google Scholar 

  6. Gusfield D: Algorithms on Strings, Trees and Sequences. 1997, New York, NY, USA: Cambridge University Press.

    Book  Google Scholar 

  7. Mosig A, Hofacker IL, Stadler PF, Zell A:Comparative analysis of cyclic sequences: viroids and other small circular RNAs. German Conference on Bioinformatics, Volume 83 of LNI. Edited by: Huson DH, Kohlbacher O, Lupas AN, Nieselt K. 2006, 93-102. GI.

    Google Scholar 

  8. Fernandes F, Pereira L, Freitas A:CSA: An efficient algorithm to improve circular DNA multiple alignment. BMC Bioinformatics. 2009, 10: 1-13.

    Article  Google Scholar 

  9. Lee T, Na JC, Park H, Park K, Sim JS:Finding optimal alignment and consensus of circular strings. Proceedings of the 21st annual Conference on Combinatorial Pattern Matching. 2010, 310-322. CPM’10, Berlin, Heidelberg: Springer-Verlag.

    Chapter  Google Scholar 

  10. Crochemore M, Hancart C, Lecroq T: Algorithms on Strings. 2007, New York, NY, USA: Cambridge University Press.

    Book  Google Scholar 

  11. Applied Combinatorics on Words. Edited by: Lothaire M. 2005, New York, NY, USA: Cambridge University Press.

    Google Scholar 

  12. Fredriksson K, Grabowski S:Average-optimal string matching. J Discrete Algorithms. 2009, 7 (4): 579-594. 10.1016/j.jda.2008.09.001.

    Article  Google Scholar 

  13. Chen KH, Huang GS, Lee RCT:Bit-parallel algorithms for exact circular string matching. Comput J. 2013, doi:10.1093/comjnl/bxt023.

    Google Scholar 

  14. Iliopoulos CS, Rahman MS:Indexing circular patterns. Proceedings of the 2nd International Conference on Algorithms and Computation. 2008, 46-57. WALCOM’08, Berlin, Heidelberg: Springer-Verlag.

    Google Scholar 

  15. Lin J, Adjeroh D:All-against-all circular pattern matching. Comput J. 2012, 55 (7): 897-906. 10.1093/comjnl/bxr126.

    Article  Google Scholar 

  16. Chang WI, Marr TG:Approximate string matching and local similarity. Proceedings of the 5th Annual Symposium on Combinatorial Pattern Matching. 1994, 259-273. CPM ’94, London, UK: Springer-Verlag.

    Chapter  Google Scholar 

  17. Fredriksson K, Navarro G:Average-optimal single and multiple approximate string matching. J Exp Algorithmics. 2004, 9:http://dl.acm.org/citation.cfm?id=1041513,

    Google Scholar 

  18. Wu S, Manber U:Fast text searching: allowing errors. Commun ACM. 1992, 35 (10): 83-91. 10.1145/135239.135244.

    Article  Google Scholar 

  19. Rivest R:Partial-match retrieval algorithms. SIAM J Comput. 1976, 5: 19-50. 10.1137/0205003.

    Article  Google Scholar 

  20. Frousios K, Iliopoulos CS, Mouchard L, Pissis SP, Tischler G:REAL: an efficient REad ALigner for next generation sequencing reads. Proceedings of the First ACM International Conference on Bioinformatics and Computational Biology. 2010, 154-159. BCB ’10, USA: ACM.

    Chapter  Google Scholar 

  21. Nong G, Zhang S, Chan WH:Linear suffix array construction by almost pure induced-sorting. Proceedings of the 2009 Data Compression Conference. 2009, 193-202. DCC ’09, Washington, DC, USA: IEEE Computer Society.

    Chapter  Google Scholar 

  22. Ilie L, Navarro G, Tinta L:The longest common extension problem revisited and applications to approximate string searching. J Discrete Algorithms. 2010, 8 (4): 418-428. 10.1016/j.jda.2010.08.004.

    Article  Google Scholar 

  23. Fischer J:Inducing the LCP-Array. Algorithms and Data Structures, Volume 6844 of Lecture Notes in Computer Science. Edited by: Dehne F, Iacono J, Sack JR. 2011, 374-385. Berlin Heidelberg: Springer.

    Google Scholar 

  24. Fischer J, Heun V:Space-efficient preprocessing schemes for range minimum queries on static arrays. SIAM J Comput. 2011, 40 (2): 465-492. 10.1137/090779759.

    Article  Google Scholar 

  25. Dori S, Landau GM:Construction of Aho Corasick automaton in linear time for integer alphabets. Inf Process Lett. 2006, 98 (2): 66-72. 10.1016/j.ipl.2005.11.019.

    Article  Google Scholar 

  26. Hall HS, Knight SR: Higher Algebra. 1950, London, UK: MacMillan.

    Google Scholar 

  27. Baeza-Yates RA, Perleberg CH:Fast and practical approximate string matching. Inform Process Lett. 1996, 59: 21-27.0.1016/0020-0190(96)00083-X.http://www.sciencedirect.com/science/article/pii/002001909600083X],

    Article  Google Scholar 

  28. Wagner RA, Fischer MJ:The string-to-string correction problem. J ACM. 1974, 21: 168-173. 10.1145/321796.321811.

    Article  Google Scholar 

  29. Hirschberg DS:A linear space algorithm for computing maximal common subsequences. Commun ACM. 1975, 18 (6): 341-343. 10.1145/360825.360861.

    Article  Google Scholar 

  30. Pizza & Chili. http://pizzachili.dcc.uchile.cl/ 2013,

  31. Peterlongo P, Pisanti N, Boyer F, do Lago AP, Sagot MF:Lossless filter for multiple repetitions with Hamming distance. J Discrete Algorithms. 2008, 6 (3): 497-509. 10.1016/j.jda.2007.03.003.

    Article  Google Scholar 

  32. Peterlongo P, Sacomoto GAT, do Lago AP, Pisanti N, Sagot MF:Lossless filter for multiple repeats with bounded edit distance. Algorithms Molecular Biol. 2009,4.http://www.almob.org/content/pdf/1748-7188-4-3.pdf,

    Google Scholar 

Download references

Acknowledgements

The publication costs for this article were funded by the Open Access funding scheme of King’s College London. CB is supported by an EPSRC grant (Doctoral Training Grant #EP/J500252/1). The authors would like to warmly thank the “Reviewer #1” and the “Reviewer #2” whose meticulous comments were beyond the call of duty.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Solon P Pissis.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors’ contributions

CSI and SPP designed the study. CB, CSI, and SPP devised the algorithms. SPP developed the library and conducted the experiments. CB and SPP wrote the manuscript with the contribution of CSI. The final version of the manuscript is approved by all authors.

Authors’ original submitted files for images

Below are the links to the authors’ original submitted files for images.

Authors’ original file for figure 1

Authors’ original file for figure 2

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 credited. The Creative Commons Public Domain Dedication waiver ( https://creativecommons.org/publicdomain/zero/1.0/ ) applies to the data made available in this article, unless otherwise stated.

Reprints and permissions

About this article

Cite this article

Barton, C., Iliopoulos, C.S. & Pissis, S.P. Fast algorithms for approximate circular string matching. Algorithms Mol Biol 9, 9 (2014). https://doi.org/10.1186/1748-7188-9-9

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1748-7188-9-9

Keywords