Skip to main content
  • Methodology Article
  • Open access
  • Published:

An efficient error correction algorithm using FM-index

Abstract

Background

High-throughput sequencing offers higher throughput and lower cost for sequencing a genome. However, sequencing errors, including mismatches and indels, may be produced during sequencing. Because, errors may reduce the accuracy of subsequent de novo assembly, error correction is necessary prior to assembly. However, existing correction methods still face trade-offs among correction power, accuracy, and speed.

Results

We develop a novel overlap-based error correction algorithm using FM-index (called FMOE). FMOE first identifies overlapping reads by aligning a query read simultaneously against multiple reads compressed by FM-index. Subsequently, sequencing errors are corrected by k-mer voting from overlapping reads only. The experimental results indicate that FMOE has highest correction power with comparable accuracy and speed. Our algorithm performs better in long-read than short-read datasets when compared with others. The assembly results indicated different algorithms has its own strength and weakness, whereas FMOE is good for long or good-quality reads.

Conclusions

FMOE is freely available at https://github.com/ythuang0522/FMOC.

Background

High-throughput sequencing technologies have been widely used in the past decade for studying disease associations or deciphering genomes. The reads generated by next generation sequencing platforms (e.g., Illumina, Roche 454) may contain several types of errors including mismatches, insertions and deletions (collectively termed indels) [1]. These errors bring great challenges of subsequent genome assembly algorithms, because false read overlaps may be produced, which further leads to fragmented assembly or even misassembly. Furthermore, these errors will also increase the size of assembly graph due to erroneous vertices and edges, which implies requirement of larger memory usage and computational time. Therefore, prior to assembly, these reads are usually corrected in the hope of producing better assembled genome [2, 3].

In order to correct these errors, existing methods mainly rely on sufficient sequencing coverage for replacing less-frequent errors with more-frequent base. These algorithms can be roughly classified into the following three categories: (1) the k-mer frequency spectrum methods slide a fixed-sized k-mer window along the entire read and replace the low-frequent k-mers with high-frequent ones (e.g., QuorUm, Lighter, BLESS, Blue, Musket, and Quake) [4–9]; (2) Methods based on suffix tree (or array) are simialr to k-mer spectrum methods but different sizes of k-mers can be used adaptively in the suffix tree/array (e.g., Fiona, SHREC, HSHREC, HiTEC) [10–13]; (3) The overlap-based correction approaches first identify reads overlapping with the query (i.e., read to be corrected) via multiple-sequence alignment (MSA). Subsequently, errors are corrected according to the major alleles in the MSA matrix constructed by only overlapping reads (e.g., Karect, Coral, and ECHO) [14–16].

Although the k-mer spectrum methods are the easiest and fastest solutions, they are unable to reliably distinguish errors from polymorphisms within repeats. Because if repeat size is larger than k-mer, the major k-mer in the spectrum may actually come from other repeat copies and lead to false correction [17, 18]. The suffix tree/array algorithms can use different sizes of k adaptively for reducing repeat ambiguity but they are still limited by larger repeats. Theoretically, overlap-based correction is least affected by repeats due to the usage of entire reads instead of smaller k-mers, and thus errors can be more reliably corrected by alleles from overlapping reads only. However, the speed of MSA is much slower owing to the complexity of computing MSA. Recently, Karect showed that that efficiency of overlap correction based on MSA can be greatly improved by representing multiple-aligned sequences as a partial-order graph [14], whereas identical sequences are collapsed into the same path and alignment can be performed for only once.

Over the past decade, FM-index is the preferred data structure underlying many state-of-the-art short-read aligners (e,g, BWA, Bowtie) [19]. These aligners have been widely used to align huge amount of short reads against reference genome with good speed and accuracy. It is mainly because FM-index compresses identical substrings into suffix array (SA) intervals, which saves both time and space for numerous repetitive sequences widespread in the genome [20]. However, to our best knowledge, FM-index was mainly used (or fine tuned) for aligning individual reads against reference genome instead of optimized for MSA, which is the most time-consuming step in overlap-based error correction.

This paper presented a novel overlap-based error correction algorithm using FM-index (called FMOE). Given a query read to be corrected, FMOE first identifies its overlapping reads by simultaneous alignment against multiple reads compressed in FM-index. Subsequently, sequencing errors are corrected by k-mer voting from overlapping reads only. The details of methods are described in the following section and the readers would be better familiar with either suffix tree/array, Burrows-Wheeler Transform, or FM-index.

Methods

Our correction algorithm follows the overlap-based correction paradigm. Given a query read (to be corrected), we first identify reads overlapping with the query by performing alignment against reads compressed in FM-index, construct a MSA matrix, and replace the less-frequent alleles on the query (i.e., errors) with the most-frequent one at the same locus. The identification of overlapping reads is the most time-consuming step. This paper addresses this key issue by using the compressed feature of FM-index, which compresses identical substrings into continuous SA intervals. Our method aims to perform alignment over identical substrings only once by combining the seed-and-extend strategy with FM-index extension [21], which is described below.

Nowadays, nearly all the alignment tools (e.g., BLAST, BWA) utilize the seed-and-extend strategy for speedup, which only align reads having common seed with the query [22]. Our algorithm also used this strategy for speedup, which is divided into three steps (see Fig. 1). The first step identifies high-confident seed (i.e., k-mer with sufficient frequency) in the query read. Subsequently, the sequences flanking the seed (i.e., overlapping reads) are forward/backward extracted using FM-index extension, and simultaneously, each of the extended sequence is aligned against the query read. Finally, the extended sequences with sufficient identity and overlap thresholds will form a MSA matrix, and the most-frequent k-mer will replace the error k-mer with lower frequency at each erroneous locus. The details of each step are presented in the following sections.

Fig. 1
figure 1

Workflow of overlap-based error correction using FM-index. Initially, a seed is identified from the high-quality regions with sufficient k-mer frequency. Subsequently, the flanking sequences are extended from the seed base by base using FM-index and are aligned against the query read. Note that GATA is a compression of all such strings in all reads. Finally, the most-frequent allele in each column of MSA will replace the error allele with lower frequency

Seed identification

The forward and reverse strand sequences of inputted reads are first used to construct forward and reverse FM-indices using Li’s ropebwt2 algorithm [22]. A k-mer frequency spectrum (k=31 by default) is constructed by randomly sampling 10,000 k-mers from the FM-index, which can provide various statistics required at different steps (e.g., mean, median). A k-mer window is slided across the entire query read for detection of potential error bases, in which the k-mer frequencies at both strands drop below a threshold t (default: median k-mer frequency*0.5)(see Fig. 2). The region with sufficient k-mer frequency flanking the error base is termed high-quality region. Within this region, the k-mer most close to the error base is identified as seed. The identified seed will be used to extract overlapping reads for alignment later. Most reads will contain only one high-quality region at 5’ end and errors at 3’ end, owing to the limitation of Illumina sequencing by synthesis at later cycles. However, we observed few reads can be divided into multiple high-quality regions by two or more sequencing errors. The seed will be selected from the largest high-quality region in such case.

Fig. 2
figure 2

Illustration of seed identification. The high-quality region is defined as the region where k-mer frequencies at both forward and reverse-complement strands are above a threshold. The seed is identified as the k-mer closest to the error base within the high-quality region. If there are multiple high-quality regions, the largest one is selected for seed identificaiton

Extraction of flanking sequences by FM-index extension

The second step of our algorithm aims to extract and to align reads overlapping with the query using FM-index. Traditional seed-and-extend alignment algorithms independently align each read (containing the seed) against the query in order to identify overlapping reads (Fig. 3 a). Instead of independent alignment, because FM-index compressed all substrings of reads into SA intervals, it allows simultaneous alignment of multiple (compressed) substrings against the query (Fig. 3 b). Below we first describe the FM-index extension algorithm which aims to (base-by-base) extract reads (containing the seed) while compressing identical substrings as one representative path sequence. In next section, we will present a faster heuristic alignment of each path sequence against the query in order to identify mismatches and indels.

Fig. 3
figure 3

Comparison of traditional seed-and-extend alignment versus compressed alignment using FM-index extension. a Without compression, all reads containing the seed will be individually aligned against the query in order to compute overlap and similarity; b With compression, all reads containing the seed will be represented by different paths during FM-index extension. These reads will be gradually extended (extracted) from the seed sequence at both directions via FM-index extension, while identical sequences are still compressed in a single path. Simultaneously, each newly extended base will be aligned against the query read

Given a seed, the flanking sequence is extended (toward both forward and backward directions) using a variant of the backward-search algorithm called FM-index extension [20, 21]. The implementation details of FM-index extension can be found in the Additional file 1, and the high-level idea is briefly described below. In the FM-index extension algorithm (Fig. 3 b), a tree data structure is used to store all the extended bases, where each tree path represents a sequence compressed by multiple identical substrings in the reads. Each tree node contains the extended base and two SA intervals (in forward/reverse FM-indices). Initially, the forward/reverse SA intervals of the seed (e.g., CGATC) are computed using the backward-search algorithm [20]. Subsequently, we recursively extend the seed sequences by querying FM-index for all possible {A,T,C,G}-extensions. This is achieved by updating the SA intervals of leaf nodes using the original algorithm of backward search for {A,T,C,G} (see Additional file 1). In addition, because forward and reverse FM-indices are built in advance, forward and backward extensions can be implemented in similar way by using FM-index of forward and reverse FM-indices.

If two or more possible {A,T,C,G}-extensions exist, new tree nodes will be created to keep all possible extension paths. Note that each path sequence represents a compression of multiple identical overlapping reads. We observed that the extension of sequences containing sequencing errors is often with lower frequency, which can be obtained according to the size of SA intervals. Thus, the extension path with insufficient frequency is pruned for speedup and for reducing search space (default: < 3) (see Additional file 1: Figure S1). The entire extension process aborts if the extended length exceeds the read length or the number of extension paths exceeds the maximum number allowed (default: 64).

Faster heuristic alignment and similarity measurement during FM-index extension

However, many reads may occasionally contain the seed but do not actually overlap with the query (i.e., dissimilar at flanking sequences). Moreover, the precise aligned positions between query and each extended sequence are required for building an alignment matrix in the last correction stage. Consequently, we have to align each representative sequence against the query during extension in order to identify mismatches/indels and measure the similarity at the same time. Traditional dynamic-programming alignment of query read against all tree paths can give exact and accurate solution but is time-consuming. Below, we present a heuristic alignment algorithm based on commonly-shared SA intervals between the query and extended sequences, which is performed along with the extension and can tolerate both mismatches and indels.

In order to match each newly-extended interval/base against the query, we pre-compute the SA intervals of all k-mers in the query and store them in an array (A) (Fig. 4 a), where A[i] stores the SA interval of i-th k-mer on the query. For each newly-extended base, the new SA interval is compared against those stored in the array A. If the query read share a common k-mer with the newly-extended sequence (i.e., match), the SA interval of the newly-extended base will be equivalent to or inclusive within that of A[i] (e.g., the forward-extended T has a common interval [10,22] with query). On the other hand, if there are mismatches, the SA interval of extended-mismatched bases will have no common SA intervals with those in A. In other words, the identification of common SA intervals is similar to finding common k-mers between the query and representative sequence, because all substrings are compressed into SA intervals in FM-index.

Fig. 4
figure 4

Illustration of heuristic alignment using common SA intervals during FM-index extension. a The SA intervals of all k-mers (k=3) in query are pre-computed and stored in an array A[i]. The forward-extended base (T) has an SA interval [10,22] inclusive within the interval [10,25] in A[i], which implies that the query and the compressed reads share common k-mer (GAT) at this locus; b Mismatches and indels will temporarily lead to no common k-mers (i.e., SA intervals in FM-index) found. In order to tolerate indels, the SA interval of any newly-extended base must be compared with those in a range according to the maximum indels allowed

Unfortunately, the presence of indel errors will shuffle the loci of common SA intervals between the query and extended sequence. As a result, the common SA intervals are not necessary at the same locus in the query and extended sequence. Figure 4 b illustrates the problem using uncompressed sequences with mismatches or indels as examples. For mismatches, the common SA intervals will be only temporarily missed and recovered at succeeding locus. For insertion or deletion errors, the common SA intervals will be found at preceding or succeeding loci in the query and extended sequence, respectively. Therefore, in order to identify common SA intervals while tolerating indels of maximum size d, we have to compare any new SA interval with those stored from A[i−d] to A[i+d]. Once any common SA interval is found, the aligned position between the query and extended sequence (i.e., loci of the common SA intervals) can be thus known and recorded, which will be used for building an alignment matrix in the last correction step.

Furthermore, because any mismatch or indel will reduce this number of common SA intervals, the similarity between the query and each extended sequence can now be computed by the number of common SA intervals divided by total number of SA intervals. The extended sequence with low similarity with the query can be thus immediately discarded without further extension. As Illumina platform has typical error rate around 1%, we discard extended sequences with error rate below 5% by default. This pruning-by-similarity procedure during FM-index extension also significantly improves the speed of our algorithm.

The proposed alignment algorithm is heuristic speedup in comparison with exact alignment algorithm using dynamic programming. We compare the time complexity of our alignment with that of exact algorithm in order to identify the source of speedup. Note that each extension is an update of existing SA interval which takes only O(1) time. Therefore, the FM-index extension takes O(r w) time, where r is the read length and w is the maximum tree paths allowed. Because we need to tolerate maximum d indels by sequential search a range of SA intervals, the entire algorithm takes O(r w d) time. Theoretically, the sequential search of SA intervals can be replaced by binary search using interval tree, which leads to better O(r w logd) time. But practically, we didn’t gain better efficiency mainly because d (indel) is very small in Illumina platforms. In comparison with independent alignment approach, which takes O(r n d) time where n is the total number of reads if using d-banded dynamic programming speedup, our method is still much faster as w is much smaller than n. When tested on real datasets, we further observed that, during FM-index extension, only one or two paths are extended for most reads instead of worst-case O(w) paths. This is probably due to the high sequencing accuracy of Illumina platforms. Therefore, the algorithm can run in almost linear time in practice.

Correction via k-mer voting from overlapping reads

Existing overlap-correction methods often build a MSA matrix after alignment of overlapping reads onto the query (Fig. 5 a). Based on the MSA matrix, the minor allele (i.e., error) on the query will be replaced with the most frequent allele at the same locus in the MSA matrix. However, we observed that, in high-GC regions where error rate is significantly elevated, the majority vote using single base is less accurate, because the most frequent allele at one locus can even come from errors. Nevertheless, although the error rate in these error-prone regions is high, there are still a few reads containing a short run of correct bases. As a consequence, the frequency of correct k-mers is larger than that of erroneous k-mers (default: k≈5). Therefore, the error correction is done by k-mer voting instead of voting by a single base. Specifically, we first count the k-mer frequency over the error based on overlapping reads derived from previous stage. Because identical reads are compressed into one extension path represented by a SA interval, the frequency of each k-mer in these overlapping reads can be known easily according to the size of SA interval. The most frequent k-mer in the MSA matrix will be used to replace the erroneous k-mer on the query (Fig. 5 b). Note that this correction approach only compute the k-mer frequency from overlapping reads for voting. In comparison with k-mer correction methods voting by k-mer counts from all reads, our method is more robust to repeats.

Fig. 5
figure 5

Comparison of single-base voting versus k-mer voting versus. a The alignment matrix of reads overlapping with query is constructed. In single-base voting, the most-frequent allele at each column will replace the less-frequent one on query. However. the major allele is not necessary the correct base in error-prone region; b In k=mer voting, the k-mer frequency over the error base is derived from previous FM-index extension. The k-mer with highest frequency at the locus will be chosen to replace the original allele. This is particularly useful in high-GC regions where the most frequent allele may not be accurate

Results

FMOE is implemented in C++ and freely available on Github (https://github.com/ythuang0522/FMOC). We compare FMOE with two other leading overlap-based methods, Karect and Coral, and four k-mer spectrum methods (QuorUm, RACER, BLESS2, and SGA). Table 1 lists the sequencing statistics of four test datasets with genome sizes ranging from 4.6 Mb to 100.2 Mb and various read lengths, where reads and reference genomes are downloaded from the GAGE-b project and NCBI [23]. We first compared these programs in terms of correction power and accuracy. The correction power and accuracy are evaluated by BWA-aligning reads onto the corresponding reference genomes in order to compute the aligned length, identity, and indels. Subsequently, we move to investigate the influence of different correction algorithms on the genome assembly.

Table 1 Genome and sequencing statistic of four data sets used in the experiments

Correction power and accuracy

Tables 2, 3, 4 and 5 list the correction power (in terms of total corrected bases and corrected read length) and accuracy (in terms of identity and indel rate) of each tool across four datasets (M.a b s c e s s u s, R.s p h a e r o i d e s, E.c o l i, and C.e l e g a n s). In general, the results indicated the FMOE obtains the best correction power in comparison with all other overlap-based or k-mer based methods in long-read datasets. Overlap-based methods tend to have higher correction power mainly due to the ability of correcting error-prone reads in high-GC regions using time-consuming alignment. On the other hand, k-mer based methods usually have high accuracy and runs much faster owing to the skip of error-prone regions. QuorUm obtains the best accuracy because it sacrifices the correction power by trimming or throwing away uncorrected reads. When restricted to overlap-based methods, the accuracy of FMOE (in terms of identity and indel rate) is best than the others in most datasets. The identify of Karect is slightly better than FMOE in the E.c o l i and C.e l e g a n s datasets, but its indel rate is worse than that of FMOE.

Table 2 Correction power/sensitivity (in terms of total corrected bases and corrected read length) and accuracy (in terms of identity and indel rate) of seven methods over M. abscessus dataset (5 Mb genome, 251 bp read length)
Table 3 Correction power and accuracy of seven methods over R. sphaeroides dataset (4.6Mb genome, 251bp read length)
Table 4 Correction power and accuracy of seven methods over E. coli dataset (4.6 Mb genome, 150 bp read length)
Table 5 Correction power and accuracy of seven methods over C.elegans dataset (100.2Mb genome, 110bp read length)

Theoretically, the overlap-based methods gain more benefits when processing longer reads in comparison with shorter reads. By comparing the long-read and short-read datasets (i.e., 251 bp, 150 bp, and 110 bp in Tables 2, 3, 4 and 5), we observed that our method FMOE has larger power than the others in the long-read datasets (e.g., 251 bp datasets). For instance, FMOE outputted average 249 bp-corrected reads whereas the 2nd best Karect only produced 196 bp-corrected reads in the M.a b s c e s s u s dataset with 251 bp reads. On the other hand, in the short-read dataset (e.g., 150 bp and 110 bp in Tables 3 and 4), the benefits of using overlap-based methods are diminishing and thus the results are not much different from those of k-mer based method.

In terms of speed, the k-mer based methods are all faster than overlap-based methods due to the lack of alignment and sacrificed power (Table 6). We observed the speed of FMOE and Karect are almost the same and both run much faster than Coral. Karect is based on partial-order alignment (POA) graph, where the identical aligned bases are collapsed into a single vertex in the graph. This implies that the compressed extension using FM-index within FMOE is similar to the POA graph, because identical sequences are also compressed into the same path sequences during FM-index extension.

Table 6 Comparison of running time

Comparison of assembly results

The reads corrected by different methods are further tested for genome assembly in order to understand the influence of correction to assembly. Existing genome assemblers are further classified into de Bruijn graph and overlap graph assemblers, which are suitable for assembling short and long reads. In order to reduce the influence from different assembly graph models, these corrected reads are assembled using a hybrid-graph assembler called StriDe which captures the features of of both de Bruijn and overlap graphs [21]. Nevertheless, we would like to note that optimized selection of genome assemblers and parameter tuning for each correction algorithm may change the results provided below. Consequently, the following results are generated by the default parameters of StriDe assembler, which only serves as one reference of possible influence of each correction algorithm to assembly. The complete evaluation of assembly is beyond the scope of this paper which focuses on error correction.

Tables 7, 8, 9 and 10 list the number of contigs, N50, NA50, misassemby, and sum of assembled bases of the seven correction algorithms tested over the four datasets. All the assembly metrics are computed by QUAST [24]. In the M.a b s c e s s u s dataset (Table 7), FMOE obtains the best assembly contiguity and accuracy as a whole (according to NA50). Karect, FMOE, QuorUm, RACER, and BLESS2 nearly assembled the expected 5 Mbp genome size, whereas Coral and SGA are significantly worse than the others in terms of contiguity (N50), accuracy (NA50 and misassembly), and completeness (Sum). In the R.s h p a e r i o i d e s dataset (Table 8), QuorUm outperforms the others in general. Further investigation indicates that this dataset is of very low sequencing quality compared with the others. The trimming procedure in QuorUm may be better and suitable for the low-quality datasets. In terms of assembly completeness, Coral only assembled a partial genome, whereas the genome size assembled by FMOE is most close to the expected 4.6 Mbp. This implies the optimization for correction power can help assembly completeness in low-quality sequencing. In the E.c o l i dataset, QuorUm and BLESS2 outperforms the others in terms of NA50, and assembly completeness of FMOE is slightly better. In large genome dataset (C.e l e g a n s), QuorUm performs much worse than all the overlap-based methods in most metrics. FMOE, RACER, and BLESS2 perform similarly and better than the others. When restricted to overlap-based correction methods, FMOE and Karect performs almost the same in short-read datasets (e.g., C.e l e g a n s), and FMOE is much more sensitive than the others in long-read datasets (e.g., M.a b s c e s s u s and R.s p h a e r o i d e s).

Table 7 Assembly results of M. abscessus
Table 8 Assembly results of R. sphaeroides
Table 9 Assembly results of E. coli
Table 10 Assembly results of C.elegans

Discussion and conclusion

This paper presented a novel overlap-based correction algorithm for NGS reads using FM-index. Our results indicated our method has larger correction power (in terms of corrected bases and read lengths) at comparable accuracy in comparison with others. We observed the compressed feature of FM-index runs almost at the same speed as a POA approach called Karect, This implies that both the partial-order graph used by Karect and FM-index used by our algorithm compressed identical reads in different manners in order to accelerate the multiple sequence alignment. In addition, we observed that, in the low-quality dataset, the k-mer based methods are superior in terms of assembly. This indicates that extremely low-quality reads may be better trimmed or discarded instead of trying to correct them for maximizing the correction power. Consequently, better correction algorithms for genome assembly may be achieved by striking a balance between correction power and accuracy for high- and low-quality reads.

References

  1. Fox EJ, Reid-Bayliss KS, Emond MJ, Loeb LA. Accuracy of next generation sequencing platforms. Next Gener Sequencing Appl. 2014; 1. https://www.omicsonline.org/open-access/accuracy-of-next-generation-sequencing-platforms-jngsa.1000106.pdf.

  2. Simpson J, Wong K, Jackman S, Schein J, Jones S, Birol I. Abyss: a parallel assembler for short read sequence data. Genome Res. 2009; 19:1117–23.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  3. Simpson JT, Durbin R. Efficient de novo assembly of large genomes using compressed data structures. Genome Res. 2012; 22(3):549–6.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  4. Marçais G, Yorke JA, Zimin A. Quorum: an error corrector for illumina reads. PLoS ONE. 2015; 10(6):0130821.

    Article  Google Scholar 

  5. Song L, Florea L, Langmead B. Lighter: fast and memory-efficient sequencing error correction without counting. Genome Biol. 2014; 15(11):1.

    Article  Google Scholar 

  6. Heo Y, Wu XL, Chen D, Ma J, Hwu WM. Bless: bloom filter-based error correction solution for high-throughput sequencing reads. Bioinformatics. 2014; 30(10):1354–62.

    Article  CAS  PubMed  Google Scholar 

  7. Greenfield P, Duesing K, Papanicolaou A, Bauer DC. Blue: correcting sequencing errors using consensus and context. Bioinformatics. 2014; 30(19):2723–32.

    Article  CAS  PubMed  Google Scholar 

  8. Liu Y, Schröder J, Schmidt B. Musket: a multistage k-mer spectrum-based error corrector for illumina sequence data. Bioinformatics. 2013; 29(3):308–15.

    Article  CAS  PubMed  Google Scholar 

  9. Kelley DR, Schatz MC, Salzberg SL. Quake: quality-aware detection and correction of sequencing errors. Genome Biol. 2010; 11(11):1.

    Article  Google Scholar 

  10. Schulz MH, Weese D, Holtgrewe M, Dimitrova V, Niu S, Reinert K, Richard H. Fiona: a parallel and automatic strategy for read error correction. Bioinformatics. 2014; 30(17):356–63.

    Article  Google Scholar 

  11. Schröder J, Schröder H, Puglisi SJ, Sinha R, Schmidt B. Shrec: a short-read error correction method. Bioinformatics. 2009; 25(17):2157–63.

    Article  PubMed  Google Scholar 

  12. Salmela L. Correction of sequencing errors in a mixed set of reads. Bioinformatics. 2010; 26(10):1284–90.

    Article  CAS  PubMed  Google Scholar 

  13. Ilie L, Fazayeli F, Ilie S. Hitec: accurate error correction in high-throughput sequencing data. Bioinformatics. 2011; 27(3):295–302.

    Article  CAS  PubMed  Google Scholar 

  14. Allam A, Kalnis P, Solovyev V. Karect: accurate correction of substitution, insertion and deletion errors for next-generation sequencing data. Bioinformatics. 2015; 31(21):3421–28.

    Article  CAS  PubMed  Google Scholar 

  15. Salmela L, Schröder J. Correcting errors in short reads by multiple alignments. Bioinformatics. 2011; 27(11):1455–61.

    Article  CAS  PubMed  Google Scholar 

  16. Kao WC, Chan AH, Song YS. Echo: a reference-free short-read error correction algorithm. Genome Res. 2011; 21(7):1181–92.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  17. Harismendy O, Ng PC, Strausberg RL, Wang X, Stockwell TB, Beeson KY, Schork NJ, Murray SS, Topol EJ, Levy S, et al. Evaluation of next generation sequencing platforms for population targeted sequencing studies. Genome Biol. 2009; 10(3):1.

    Article  Google Scholar 

  18. Treangen TJ, Salzberg SL. Repetitive dna and next-generation sequencing: computational challenges and solutions. Nat Rev Genet. 2012; 13(1):36–46.

    CAS  Google Scholar 

  19. Li H, Durbin R. Fast and accurate short read alignment with Burrows-Wheeler transform. Bioinformatics. 2009; 25(14):1754–60.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  20. Ferragina P, Manzini G. Opportunistic Data Structures with Applications. In: Proceedings of the 41st Annual Symposium on Foundations of Computer Science. Redondo Beach: IEEE: 2000. p. 390–8.

    Google Scholar 

  21. Huang YT, Liao CF. Integration of string and de bruijn graphs for genome assembly. Bioinformatics. 2016; 32(9):1301–7.

    Article  CAS  PubMed  Google Scholar 

  22. Li H, Durbin R. Fast and accurate long-read alignment with Burrows-Wheeler transform. Bioinformatics. 2010; 26(5):589–95.

    Article  PubMed  PubMed Central  Google Scholar 

  23. Magoc T, Pabinger S, Canzar S, Liu X, Su Q, Puiu D, Tallon LJ, Salzberg SL. Gage-b: an evaluation of genome assemblers for bacterial organisms. Bioinformatics. 2013; 29(14):1718–25.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  24. Gurevich A, Saveliev V, Vyahhi N, Tesler G. QUAST: quality assessment tool for genome assemblies. Bioinformatics. 2013; 29(8):1072–5.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

Download references

Acknowledgements

The authors thanks the valuation suggestions from the reviewers for improving the quality of this paper. Special thanks to KMC, TJC, and HKT for their encouragement.

Funding

This work was supported in part by the MOST grant 106-2221-E-194-056-MY3.

Availability of data and materials

The reads of M. abscessus and R. sphaeroides were downloaded from the GAGE-b project [23]. Reads of E. coli and C. elegans were downloaded and NCBI short read achieve with accession numbers SRR826442, SRR826444, SRR826446, and SRR826450 for E. coli and DRR008444 for C. elegans. The source code has been deposited at http://github.com/ythuang0522/FMOC.

Author information

Authors and Affiliations

Authors

Contributions

YTH design the algorithm. YTH and YWH implemented different components of this software. YTH wrote the manuscript. Both authors read and approved the final manuscript.

Corresponding author

Correspondence to Yao-Ting Huang.

Ethics declarations

Ethics approval and consent to participate

Not applicable.

Consent for publication

Not applicable.

Competing interests

The authors declare that they have no competing interests.

Publisher’s Note

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

Additional file

Additional file 1

Supplementary method and figures are provided in this file. (PDF 661 kb)

Rights and permissions

Open Access This article is distributed under the terms of the Creative Commons Attribution 4.0 International License (http://creativecommons.org/licenses/by/4.0/), which permits unrestricted use, distribution, and reproduction in any medium, provided you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons license, and indicate if changes were made. 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.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Huang, YT., Huang, YW. An efficient error correction algorithm using FM-index. BMC Bioinformatics 18, 524 (2017). https://0-doi-org.brum.beds.ac.uk/10.1186/s12859-017-1940-1

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://0-doi-org.brum.beds.ac.uk/10.1186/s12859-017-1940-1

Keywords