Skip to main content

TECHNOLOGY AND CODE article

Front. Genet., 28 May 2021
Sec. Computational Genomics

UMIc: A Preprocessing Method for UMI Deduplication and Reads Correction

  • 1Institute of Applied Biosciences, Centre for Research and Technology Hellas, Thessaloniki, Greece
  • 2Department of Genetics, Development and Molecular Biology, School of Biology, Aristotle University of Thessaloniki, Thessaloniki, Greece
  • 3Unit for Hematological Diagnostics, Department of Internal Medicine II, University Medical Center Schleswig-Holstein, Kiel, Germany
  • 4Laboratory for MEMS Applications, IMTEK-Department of Microsystems Engineering, University of Freiburg, Freiburg, Germany
  • 5Hahn-Schickard, Freiburg, Germany

A recent refinement in high-throughput sequencing involves the incorporation of unique molecular identifiers (UMIs), which are random oligonucleotide barcodes, on the library preparation steps. A UMI adds a unique identity to different DNA/RNA input molecules through polymerase chain reaction (PCR) amplification, thus reducing bias of this step. Here, we propose an alignment free framework serving as a preprocessing step of fastq files, called UMIc, for deduplication and correction of reads building consensus sequences from each UMI. Our approach takes into account the frequency and the Phred quality of nucleotides and the distances between the UMIs and the actual sequences. We have tested the tool using different scenarios of UMI-tagged library data, having in mind the aspect of a wide application. UMIc is an open-source tool implemented in R and is freely available from https://github.com/BiodataAnalysisGroup/UMIc.

Introduction

The introduction of next-generation sequencing (NGS) has revolutionized genomic research and has impacted tremendously clinical applications (Lander et al., 2001; Shen et al., 2015). Through the NGS technologies, researchers are able to study whole genomes (whole-genome sequencing) or smaller regions (exome sequencing), with an unparalleled depth and sensitivity compared to Sanger sequencing (Shen et al., 2015). However, detection of variants with low frequency (below ∼1–3%) still remains a difficult task because of background noise (Fox et al., 2014).

In clinical applications, the detection of true mutants in low-frequency alleles or rare subclones that may contribute to the disease at an early stage remains a big challenge for cancer studies. This is mainly due to the NGS library preparation process, which includes multiple rounds of polymerase chain reaction (PCR) amplification, introducing PCR duplicates and artifacts in the output sequence. This limitation was overcome by the use of unique molecular identifiers (UMIs), facilitating detection and removal of PCR duplicates. Sample preparation involves the introduction of a UMI to each target molecule before PCR amplification. A UMI is a short sequence (usually 8–16 nucleotides, but this can vary depending on the study) that is specific to a molecule and is generated by permutations of a string of randomized nucleotides (Kivioja et al., 2011; Islam et al., 2014).

This method allows monitoring of each target molecule and, consequently, helps reduce PCR amplification bias and increase the accurate quantification and subsequent comparison of targets. UMIs can be used in different NGS methods (Kinde et al., 2011; Salk et al., 2018; Saunders et al., 2020) in a variety of approaches. The most common process to analyze these data is by aligning the sequences to a reference genome or transcriptome with the UMI tag attached to the header. Then, the reads with the same alignment coordinates and UMIs are deduplicated [e.g., UMI-tools (Smith et al., 2017), Picard, zUMIs (Parekh et al., 2018), gencore (Chen et al., 2019), Je (Girardot et al., 2016), etc.]. More recently, tools that skip the alignment step have been developed with a gain in speed on larger datasets [e.g., Calib (Orabi et al., 2019)]. In either scenario, the methods for grouping the reads by their UMIs are similar. The typical process keeps the read that has the highest UMI frequency and the highest quality score (Liu, 2019). Also, many of these tools are not considering the errors introduced to the UMI sequencing and are not be able to estimate the number of true UMIs.

From a different perspective, we have developed a method in which the extraction of the consensus read is performed at the nucleotide level, taking into account the frequency of the bases and their mean quality. We propose an R-based framework, called UMIc, which is a preprocessing step of the raw fastq files based on an alignment-free method. The tool takes as input a fastq file and generates a new fastq file in which each read represents the consensus sequence of a group of unique UMIs. The method for the grouping of reads combines correction of the UMIs and the actual sequence calculating distances between the UMIs and the sequences, respectively. Our approach was tested on empirical UMI-tagged library data from Stahlberg et al. (2017) and Zilionis et al. (2017).

Materials and Methods

Overview

Briefly, the workflow of UMIc consists of three main steps:

1. Initial read correction of the sequences with the same UMI, using the previously described method.

2. UMI merging, taking into account both the distance of the UMIs and the distance of the sequences, generated by the first step.

3. Final read correction of the sequences that belong to the same group of merged UMIs, as created by the second step.

Project link: https://github.com/BiodataAnalysisGroup/UMIc

Operating system: Windows

Programming language: R

License: MIT

Workflow

UMIc contains one script (UMIsProject.R) with another two scripts of dependency including the required functions (casesWorkflows.R, functions.R). The UMIs have to be attached to the start of the read, and the length depends on the user’s scenarios (user’s option). UMIc can be implemented on three different kinds of libraries (Figure 1): (i) single-read libraries: UMI on R1 (Read1), (ii) paired-end libraries: UMI on R1, and (iii) paired-end libraries: UMI on R1 and R2 (Read2).

FIGURE 1
www.frontiersin.org

Figure 1. Graphical representation of working cases of the UMIc tool.

The input data must be provided in fastq files, and it is assumed that the UMI is placed at the beginning of each sequence and contains a UMI-tagged library. The output data are stored also in fastq files, with the same name as the input files including the corrected reads (i.e., consensus sequences resulting from the same UMI). The first phase includes the automated process of reading fastq files at a working directory. The library preparation step of the input files must be generated using the same protocol and fulfill the same input parameters described. Then, the workflow consists of the selected criteria by users relating to their analysis (Table 1).

TABLE 1
www.frontiersin.org

Table 1. Selected criteria being input from the users.

Read Correction Method

We developed a method for the correction of (i) the UMI and (ii) the downstream sequence at the nucleotide level, taking into account the frequency of each base and their mean quality. In more detail, this process can be outlined as follows:

1. Calculation of the frequency and the mean quality of each base.

2. Setting a criterion, defined by the mean of the two previously calculated values of each base.

3. Selection of the base with the maximum value criterion.

4. In case of a draw between bases, selection of the base with the maximum quality value.

5. Setting the new quality as the selected base’s mean quality, calculated in step 1.

These steps result in the generation of a consensus sequence of the initial UMI+read.

UMI Merging Method

The process starts with the data-cleaning module. The UMIs that fulfill the condition of minimum reads per UMI are selected for the downstream analysis (the user can set this minimum by changing the parameter countsCutoff). Then, the UMIs are grouped according to specific criteria, and this serves to initiate the deduplication of the reads, keeping the initial sequences resulting from the same UMI. The main idea is described in Figure 2 and in the following steps:

FIGURE 2
www.frontiersin.org

Figure 2. Graphical representation of the UMI merging method. (A) Grouping of the reads with the same UMI and selection of the bases for the generation of the consensus sequence. (B) Grouping of the UMIs with specific distances and inspection of the distance of the actual read in order to merge the reads resulting from the same UMI.

• Finding the UMI with the maximum number of reads.

• Calculation of the distances (Hamming distances) between the UMIs with the maximum number of reads to all the other UMIs, and the same is performed for the corresponding sequence to all the other sequences.

• Finding the reads that fulfill the distance criteria (user selection) and grouping on the UMI with the maximum number of reads.

• Read correction step, as previously described in Read Correction Method.

• Removal of the associated reads from the list and continuation of the process with the second UMI with the maximum number of reads.

Output Files

The output files are stored in a new folder of the working directory named by the user. The output data are stored in fastq files with the same root name as the input files with the addition of the suffix “_corrected.” The files contain the corrected sequences (without the UMI) and the corresponding quality resulting from the mean of the selected base.

The framework also produces a “summary_table.csv” including all the information of the output fastq files, as well as extra information that can help the user to return from the output sequences to their corresponding input sequences. It is organized in a table (Figure 3), in which each row is an output sequence.

FIGURE 3
www.frontiersin.org

Figure 3. Example of the output csv table with all relevant information of the fastq files.

Results

Implementation

The proposed framework for the deduplication and error correction of UMI libraries was evaluated on two different kinds of library preparation steps. The first dataset is a UMI-tagged paired-end library generated as described in Girardot et al. (2016). In this case, the UMIs are 12nt long and are at the very beginning of R1. The second dataset is also UMI-tagged paired-end library and contains two different samples generated by the approach of Zilionis et al. Orabi et al. (2019). Here, the UMIs are 10 nt long and are at the very beginning of R1 and R2. The implementation was performed based on the available datasets and on different use cases: (i) single-end libraries: UMI on R1, (ii) paired-end libraries: UMI on R1, and (iii) paired-end libraries: UMI on R1 and R2. The use case (ii) contains the first dataset selected for the following section avoiding repetitions to be mentioned in all the use cases with the related datasets.

Complexity

Regarding the theoretical complexity, it can be roughly calculated in the following way. First, we define the following constants:

m: number of sequences

n: length of sequences

k: length of UMIs

We proceed to an estimation of the theoretical complexity, by splitting the workflow of the toolkit into its most basic parts. Just a reminder that the workflow is analytically presented both on paper and in the wiki method page of the GitHub repository as well.

(1) Data cleaning: O(mk)

(2) Read correction: O(km2)+O(mn), because

(a) Identifying the same UMIs: O(km2)

(b) Read correction: O(mn)

(3) UMI merging: O(km2)+O(nm2)

(a) Hamming distance between first UMI and the rest of them: O(km)

(b) Calculation of Hamming distances between sequences: O(mn)

(c) For each UMI: O(m)×{sumofpreviouscomplexities}

(4) Final read correction: O(km2)+O(mn)

So, an overall estimation of the theoretical complexity is

O [ ( k + n ) m 2 + ( k + n ) m ]

It is important to mention here that this is a very rough estimation of the complexity, but it is definitely an upper bound. For example, the complexity of read correction part consists of two terms: O(km2) and O(mn). The first term is associated with finding identical UMIs and the second one in applying the reading correction process in the sequences. However, there is definitely a trade-off between the two terms. At an extreme scenario where all UMIs are identical, the second term reaches its highest value O(mn), whereas the first one degenerates to O(mk). The latter scenario could be also considered as the best-case scenario, in which the computation time reaches an Ω[(n + k)⋅m] complexity. In contrast, at a scenario where all UMIs are unique, the first term reaches its highest value O(km2), but there is no read correction process, so the second term is zeroed. Same holds, more or less, at the UMI merging part. In practice, the computation time seems to grow almost linearly with respect to sample size m.

We generated 20 artificial datasets by randomly sampling different numbers of rows from the original dataset. The datasets consisted of 1,000 to 1,000,000 reads and were used as input to UMIc, selecting case 1 as a workflow (paired-end libraries and UMI in Read1). Below we present a table containing the computational time of UMIc for each one of the artificial datasets and the number of Hamming distances (Table 2). All experiments were performed on a 24-core Unix cluster with 220 GB RAM.

TABLE 2
www.frontiersin.org

Table 2. A table containing the computational time of UMIc for each one of the artificial datasets.

Figure 4 shows the computational time required for various datasets and therefore provides an estimate of the underlying complexity. In order to identify the best-fitting function, we used both linear and quadratic estimates; however, quadratic fit seems to be a degenerated version of the linear one, which further enhances our argument that our theoretical analysis corresponds to the worst-case scenario. In practice, computation time seems to grow linearly with respect to sample size.

FIGURE 4
www.frontiersin.org

Figure 4. Execution time with respect to different sample sizes. In the graph, the actual time points were fit to a linear and a quadratic function. Moreover, an upper and a lower bound of the estimated complexity is also included.

Case Report

The used dataset contains 108,001 reads, and we found 1,304 UMIs after extracting the first 12 bp of the R1 fastq file from a UMI-tagged library. Applying the data-cleaning step using the countsCutoff resulted in 106,401 reads with 344 related UMIs (Figure 5A). After the merging of the UMIs, we ended up with 286 unique DNA molecules (criteria: UMI distance = 1, sequence distance = 3, min counts cutoff = 6) (Figure 5B). In other words, the input fastq file contains 108,001 reads, and the output fastq files include the 286 UMIs resulting from the UMIc workflow. The process collapses the reads derived from the same UMI and contributes to the creation of the consensus sequence. An example of a UMI with the bases before and after correction is displayed in Figure 5C. The UMIs were merged and corrected based on our approach, and 33 UMIs that showed merging with other UMIs were displayed in Figure 6A. Particularly, we examined the merging and correction steps of a random read (M03403:12:000000000-CNPJD:1:1101:15600:2169 1:N:0:CCCTCATC+CTGTCGCT). The UMI of the read was GAGCTTCAACTC, and we found 1,001 reads with the same UMI. Then, after scanning the other reads that met the criteria of distance, we found three more groups of reads with the UMIs GCGCTTCAACTC, GATCTTCAACTC, GAGCTTCCACTC and number of reads 23, 13, and 12, respectively (Figure 6B). The R1 showed no distance between the actual reads, and the R2 showed a distance range from 0 to 2 bases.

FIGURE 5
www.frontiersin.org

Figure 5. (A) Pie chart of the sequences before and after the data-cleaning step. (B) Bar plot of the UMIs found on the raw fastq file (start) and the UMIs remaining after the cleaning and the merging steps. (C) Frequency bar plot of the bases from 13,020 reads in each position using the UMI GTAAAACGACGG after and before correction.

FIGURE 6
www.frontiersin.org

Figure 6. (A) Bar plots showing the number of reads on the merged UMIs. (B) Dot plots of a group of four UMIs on the x-axis and the distance of the reads on the y-axis on R1 and R2. The density and the size of the dots represent the number of reads after merging.

Comparison to Relevant Approaches

We used UMI-tools (Smith et al., 2017), a software toolbox for dealing with UMIs and single-cell RNA-Seq cell barcodes and pRESTO (Vander Heiden et al., 2014), a toolkit for processing raw reads from high-throughput sequencing of B-cell and T-cell repertoires including features for UMIs, in order to compare its functionalities with UMIc. The main differences are listed in Table 3.

TABLE 3
www.frontiersin.org

Table 3. Comparison of functionalities offered by UMIc, UMI-tools, and pRESTO.

A clear advantage of UMIc is that, by omitting the alignment step to a reference genome, it allows us to analyze data from hypervariable regions, such as the B- and T-cell receptor sequences (BCR and TCR sequencing). Traditional alignment/mapping tools such as bowtie that are used on UMI-tools are unable to analyze this kind of data, given that none of the reference genomes (hg19 or hg38) include information of the V(D)J construction. In this perspective, UMIc’s alignment-free approach has the advantage of excluding the UMIs during analysis, and deduplicating the corresponding sequences, therefore building a unique consensus without the need of chromosomal location information, which is very complex in the cases of BCR and TCR sequencing. Indeed, testing and validation of UMIc were performed using BCR sequencing data; it is important to highlight that UMI-tools are not able to effectively process them. However, and in order to provide an effective comparison between UMI-tools and UMIc, we used the test dataset provided by UMI-tools and our own validation dataset independently, after ensuring that their respective characteristics are comparable. Specifically, UMI-tools provide a test dataset that contains ∼1 million reads after mapping, with the read length ranging from 22 to 76 bps. In order to perform an appropriate comparison, for UMIc, we also used single-end raw reads (∼1 million), after manually trimming them to the maximum length of the corresponding reads from UMI-tools (i.e., 76 bp).

For UMI-tools, the UMI extraction required 158 s (∼2.5 min) to complete, the alignment step to the reference genome was completed in ∼20 min, and the deduplication step was performed in 69 s (∼1 min). Overall, the UMI-tools workflow needed ∼24 min to complete. UMIc was able to complete the entire process in 990.175 s (∼16.5 min). Regarding the memory requirements of the UMIc workflow, after data cleaning, the overall memory used was ∼890 MByte. After building the first consensus across all reads, the memory footprint increased to ∼932 MByte and finally decreasing to ∼878 MBytes after UMI merging. All experiments for both tools were performed on the same UNIX-based environment with 220 GB RAM available and using only a single thread.

As an additional comparison, we used pRESTO, which is a toolkit for processing raw reads from high-throughput sequencing of B- and T-cell repertoires. However, pRESTO requires a file containing primer sequences in order to properly identify the UMIs. As our tool was tested on two different data types produced by different protocols (Stahlberg et al. and Zilionis et al.), only the former one contained primer sequences. The latter does not contain any primers (as the underlying protocol does not require primer sequencing) and therefore could not be analyzed by the pRESTO tool. Ultimately, the dataset that was used to evaluate both pRESTO and UMIc contains 1,304 UMIs; 571 distinct UMIs were identified by pRESTO and 286 by UMIc. However, UMIc also takes into consideration the number of reads present in each UMI. By applying the same filtering on the results generated by pRESTO, we ended up with 174 UMIs remaining from pRESTO (Figure 7A), of which 124 UMIs were common to the 286 UMIs produced by UMIc (Figure 7B), clearly highlighting the discovery sensitivity of our approach (Figure 7C). To summarize, our approach (i) does not require a primer sequencing file and is applicable on (ii) all the NGS experiments (RNA-seq, DNA-seq, etc.) not only on BCR-seq data and (iii) the different library preparation protocols.

FIGURE 7
www.frontiersin.org

Figure 7. Bar plots showing the number of UMIs processed at each step by (A) pRESTO and (B) UMIc as well as (C) the common UMIs of the two tools.

Discussion

Unique molecular identifiers can be used to identify PCR duplicates from the amplification steps on NGS experiments (Kivioja et al., 2011; Islam et al., 2014). By adding a random UMI in each read, it is possible to exclude duplicates based on the unique UMIs. UMIs are introduced in many NGS experiments such as RNA-seq, single-cell RNA-seq (scRNA-seq) (Zilionis et al., 2017; Srivastava et al., 2019), BCR repertoire sequencing (Egorov et al., 2015), etc. Also, it is worth noting that the UMI approach is suitable for NGS-based measurable residual disease detection, which allows the determination of individual risk in acute myeloid leukemia patients based on mutational clearance after treatment (Yoest et al., 2020) and the IG/TR rearrangements in acute lymphoblastic leukemia (Bruggemann et al., 2019). However, and despite the increase in bioinformatics tools for UMI analysis, there exists no single approach to efficiently remove UMIs and correct reads accordingly.

In this work, we propose a novel tool, namely, UMIc, which provides a complete framework to analyze UMI-tagged libraries. Our approach is easily applicable to any type of fastq files with the prerequisite of the existence of UMIs at the beginning of the reads. The UMIc implementation supports a fast execution for generating (i) the corrected fastq files and (ii) a table in csv format including additional information of the output fastq files.

In relation to other existing tools, UMIc is a preprocessing step skipping the alignment step and deduplicates and corrects reads directly based on the DNA sequence. By omitting the alignment, our method is faster on larger datasets. The output contains corrected fastq files in which each read emerges from the deduplication of the UMIs during the generation of a consensus sequence. The criterion of the consensus sequence takes into account both the frequency and the mean Phred quality of nucleotides.

A number of tools have been developed that contain a fixed workflow including the sequence assembly, such as migec (Shugay et al., 2014) and pRESTO (Vander Heiden et al., 2014), tailored to the analysis of BCR and TCR repertoire sequencing. Their design has been mainly driven by the specificity of the data, which cannot be readily analyzed with traditional mappers such as bwa, bowtie2, and others. The UMIc approach of omitting the mapping on a reference genome addresses this challenge by supporting its use as a preprocessing step. This means that the user can, after the application of UMIc, continue the analysis on their pipeline of preference such as IMGT (Alamyar et al., 2012), HISAT2 (Kim et al., 2019), or bwa (Li and Durbin, 2009), using the fastq files produced as output from the proposed framework. To achieve this, UMIc takes into account the distances of sequences separating the UMI and the actual read. The UMI meeting the criteria of distance with the other UMIs (e.g., 1 bp) is examined for the distances between the remaining sequences. Moreover, the duplicated sequences will result in a short distance between the actual reads due to sequencing errors.

Overall, UMIc provides a complete framework to analyze UMI-tagged libraries. These libraries need to go through a demultiplexing and error-correcting process, based on the unique UMIs that serve as monitors of the original module (e.g., a DNA fragment). We see UMIc as a broad-use tool, similarly to other trimming and preprocessing tools, such as Trim Galore! which produces correcting and adaptor-free reads. In the same overall philosophy, our approach serves as a preprocessing step of fastq files for deduplication of reads and also an error correction step, toward building consensus sequences from each UMI. The significant novelty of UMIc is that, by skipping the alignment step, it enhances the downstream analysis and therefore can be directly added to several NGS workflows as a preprocessing step. This allows the user to be able to use any tools based on preference and the respective NGS experiments; for example, if the input fastq files are DNA-seq, the user can perform the alignment process using bwa directly on the output of UMIc. This approach offers a wide application of the UMIc tool completely independently of the overall selected computational pipeline (RNA-seq, DNA-seq, and BCR-seq).

UMIc has been implemented as an open-source R package, in accordance with the FAIR principles (Findable, Accessible, Interoperable, Reusable) for research software (Lamprecht et al., 2020). The tool is freely available on GitHub1 under an MIT license, including detailed documentation of installation and implementation, highlighting the reproducibility of the source code.

Overall, there is a growing need for appropriate tools for error correction on NGS experiments. The use of UMIs is promising, yet because of their recent implementation, the downstream analysis of these kinds of NGS data is still an ongoing process. Our method gives a new perspective toward analyzing UMIs by offering a short execution time in R language, which provides the opportunity of generating corrected fastq files from the initial raw data.

Data Availability Statement

The original contributions presented in the study are included in the article/supplementary material and through the GitHub repository (https://github.com/BiodataAnalysisGroup/UMIc), further inquiries can be directed to the corresponding author.

Author Contributions

MT designed the study and wrote the manuscript. MCM, AT, and NP developed the tool, analyzed the data, and wrote the manuscript. MK and TH provided the data and reviewed the submitted version. IK reviewed the manuscript. AC supervised the study and reviewed the submitted version. FP designed and supervised the study, and reviewed the manuscript. All authors contributed to the article and approved the submitted version.

Funding

This work was financially supported by the TRANSCAN-2 Fourth Joint Transnational Call (JTC 2017) within the project “Quant-ALL.” This research has also been co-financed by the European Regional Development Fund of the European Union and Greek National Funds through the Operational Program Competitiveness, Entrepreneurship, and Innovation under the call RESEARCH – CREATE – INNOVATE (GenOptics, project code: T2EΔK -00407).

Conflict of Interest

The authors declare that the research was conducted in the absence of any commercial or financial relationships that could be construed as a potential conflict of interest.

Footnotes

  1. ^ https://github.com/BiodataAnalysisGroup/UMIc

References

Alamyar, E., Duroux, P., Lefranc, M. P., and Giudicelli, V. (2012). IMGT((R)) tools for the nucleotide analysis of immunoglobulin (IG) and T cell receptor (TR) V-(D)-J repertoires, polymorphisms, and IG mutations: IMGT/V-QUEST and IMGT/HighV-QUEST for NGS. Methods Mol. Biol. 882, 569–604. doi: 10.1007/978-1-61779-842-9_32

CrossRef Full Text | Google Scholar

Bruggemann, M., Kotrova, M., Knecht, H., Bartram, J., Boudjogrha, M., Bystry, V., et al. (2019). Standardized next-generation sequencing of immunoglobulin and T-cell receptor gene recombinations for MRD marker identification in acute lymphoblastic leukaemia; a EuroClonality-NGS validation study. Leukemia 33, 2241–2253. doi: 10.1038/s41375-019-0496-7

PubMed Abstract | CrossRef Full Text | Google Scholar

Chen, S., Zhou, Y., Chen, Y., Huang, T., Liao, W., Xu, Y., et al. (2019). Gencore: an efficient tool to generate consensus reads for error suppressing and duplicate removing of NGS data. BMC Bioinformatics 20(Suppl 23):606. doi: 10.1186/s12859-019-3280-9

PubMed Abstract | CrossRef Full Text | Google Scholar

Egorov, E. S., Merzlyak, E. M., Shelenkov, A. A., Britanova, O. V., Sharonov, G. V., Staroverov, D. B., et al. (2015). Quantitative profiling of immune repertoires for minor lymphocyte counts using unique molecular identifiers. J Immunol. 194, 6155–6163. doi: 10.4049/jimmunol.1500215

PubMed Abstract | CrossRef Full Text | Google Scholar

Fox, E. J., Reid-Bayliss, K. S., Emond, M. J., and Loeb, L. A. (2014). Accuracy of next generation sequencing platforms. Next Gener. Seq. Appl. 1:1000106.

Google Scholar

Girardot, C., Scholtalbers, J., Sauer, S., Su, S. Y., and Furlong, E. E. (2016). Je, a versatile suite to handle multiplexed NGS libraries with unique molecular identifiers. BMC Bioinformatics 17:419. doi: 10.1186/s12859-016-1284-2

PubMed Abstract | CrossRef Full Text | Google Scholar

Islam, S., Zeisel, A., Joost, S., La Manno, G., Zajac, P., Kasper, M., et al. (2014). Quantitative single-cell RNA-seq with unique molecular identifiers. Nat. Methods 11, 163–166. doi: 10.1038/nmeth.2772

PubMed Abstract | CrossRef Full Text | Google Scholar

Kim, D., Paggi, J. M., Park, C., Bennett, C., and Salzberg, S. L. (2019). Graph-based genome alignment and genotyping with HISAT2 and HISAT-genotype. Nat. Biotechnol. 37, 907–915. doi: 10.1038/s41587-019-0201-4

PubMed Abstract | CrossRef Full Text | Google Scholar

Kinde, I., Wu, J., Papadopoulos, N., Kinzler, K. W., and Vogelstein, B. (2011). Detection and quantification of rare mutations with massively parallel sequencing. Proc. Natl. Acad. Sci. U.S.A. 108, 9530–9535. doi: 10.1073/pnas.1105422108

PubMed Abstract | CrossRef Full Text | Google Scholar

Kivioja, T., Vaharautio, A., Karlsson, K., Bonke, M., Enge, M., Linnarsson, S., et al. (2011). Counting absolute numbers of molecules using unique molecular identifiers. Nat. Methods 9, 72–74. doi: 10.1038/nmeth.1778

PubMed Abstract | CrossRef Full Text | Google Scholar

Lamprecht, A.-L., Garcia, L., Kuzak, M., Martinez, C., Arcila, R., Martin Del Pico, E., et al. (2020). Towards FAIR principles for research software. Data Sci. 3, 37–59.

Google Scholar

Lander, E. S., Linton, L. M., Birren, B., Nusbaum, C., Zody, M. C., Baldwin, J., et al. (2001). Initial sequencing and analysis of the human genome. Nature 409, 860–921. doi: 10.1038/35057062

PubMed Abstract | CrossRef Full Text | Google Scholar

Li, H., and Durbin, R. (2009). Fast and accurate short read alignment with Burrows-Wheeler transform. Bioinformatics 25, 1754–1760. doi: 10.1093/bioinformatics/btp324

PubMed Abstract | CrossRef Full Text | Google Scholar

Liu, D. (2019). Algorithms for efficiently collapsing reads with unique molecular identifiers. PeerJ. 7:e8275. doi: 10.7717/peerj.8275

PubMed Abstract | CrossRef Full Text | Google Scholar

Orabi, B., Erhan, E., McConeghy, B., Volik, S. V., Le Bihan, S., Bell, R., et al. (2019). Alignment-free clustering of UMI tagged DNA molecules. Bioinformatics 35, 1829–1836. doi: 10.1093/bioinformatics/bty888

PubMed Abstract | CrossRef Full Text | Google Scholar

Parekh, S., Ziegenhain, C., Vieth, B., Enard, W., and Hellmann, I. (2018). zUMIs–A fast and flexible pipeline to process RNA sequencing data with UMIs. Gigascience 7:giy059.

Google Scholar

Salk, J. J., Schmitt, M. W., and Loeb, L. A. (2018). Enhancing the accuracy of next-generation sequencing for detecting rare and subclonal mutations. Nat. Rev. Genet. 19, 269–285. doi: 10.1038/nrg.2017.117

PubMed Abstract | CrossRef Full Text | Google Scholar

Saunders, K., Bert, A. G., Dredge, B. K., Toubia, J., Gregory, P. A., Pillman, K. A., et al. (2020). Insufficiently complex unique-molecular identifiers (UMIs) distort small RNA sequencing. Sci. Rep. 10:14593.

Google Scholar

Shen, T., Pajaro-Van de Stadt, S. H., Yeat, N. C., and Lin, J. C. (2015). Clinical applications of next generation sequencing in cancer: from panels, to exomes, to genomes. Front. Genet. 6:215. doi: 10.3389/fgene.2015.00215

PubMed Abstract | CrossRef Full Text | Google Scholar

Shugay, M., Britanova, O. V., Merzlyak, E. M., Turchaninova, M. A., Mamedov, I. Z., Tuganbaev, T. R., et al. (2014). Towards error-free profiling of immune repertoires. Nat. Methods 11, 653–655. doi: 10.1038/nmeth.2960

PubMed Abstract | CrossRef Full Text | Google Scholar

Smith, T., Heger, A., and Sudbery, I. (2017). UMI-tools: modeling sequencing errors in unique molecular identifiers to improve quantification accuracy. Genome Res. 27, 491–499. doi: 10.1101/gr.209601.116

PubMed Abstract | CrossRef Full Text | Google Scholar

Srivastava, A., Malik, L., Smith, T., Sudbery, I., and Patro, R. (2019). Alevin efficiently estimates accurate gene abundances from dscRNA-seq data. Genome Biol. 20:65.

Google Scholar

Stahlberg, A., Krzyzanowski, P. M., Egyud, M., Filges, S., Stein, L., and Godfrey, T. E. (2017). Simple multiplexed PCR-based barcoding of DNA for ultrasensitive mutation detection by next-generation sequencing. Nat. Protoc. 12, 664–682. doi: 10.1038/nprot.2017.006

PubMed Abstract | CrossRef Full Text | Google Scholar

Vander Heiden, J. A., Yaari, G., Uduman, M., Stern, J. N., O’Connor, K. C., Hafler, D. A., et al. (2014). pRESTO: a toolkit for processing high-throughput sequencing raw reads of lymphocyte receptor repertoires. Bioinformatics 30, 1930–1932. doi: 10.1093/bioinformatics/btu138

PubMed Abstract | CrossRef Full Text | Google Scholar

Yoest, J. M., Shirai, C. L., and Duncavage, E. J. (2020). Sequencing-based measurable residual disease testing in acute myeloid leukemia. Front. Cell Dev. Biol. 8:249. doi: 10.3389/fcell.2020.00249

PubMed Abstract | CrossRef Full Text | Google Scholar

Zilionis, R., Nainys, J., Veres, A., Savova, V., Zemmour, D., Klein, A. M., et al. (2017). Single-cell barcoding and sequencing using droplet microfluidics. Nat. Protoc. 12, 44–73. doi: 10.1038/nprot.2016.154

PubMed Abstract | CrossRef Full Text | Google Scholar

Keywords: unique molecular identifiers, molecular barcodes, error correction, next-generation sequencing, bioinformatics

Citation: Tsagiopoulou M, Maniou MC, Pechlivanis N, Togkousidis A, Kotrová M, Hutzenlaub T, Kappas I, Chatzidimitriou A and Psomopoulos F (2021) UMIc: A Preprocessing Method for UMI Deduplication and Reads Correction. Front. Genet. 12:660366. doi: 10.3389/fgene.2021.660366

Received: 29 January 2021; Accepted: 08 April 2021;
Published: 28 May 2021.

Edited by:

Juan Caballero, European Bioinformatics Institute (EMBL-EBI), United Kingdom

Reviewed by:

Avi Srivastava, New York Genome Center, United States
Thierry Lecroq, Université de Rouen, France

Copyright © 2021 Tsagiopoulou, Maniou, Pechlivanis, Togkousidis, Kotrová, Hutzenlaub, Kappas, Chatzidimitriou and Psomopoulos. This is an open-access article distributed under the terms of the Creative Commons Attribution License (CC BY). The use, distribution or reproduction in other forums is permitted, provided the original author(s) and the copyright owner(s) are credited and that the original publication in this journal is cited, in accordance with accepted academic practice. No use, distribution or reproduction is permitted which does not comply with these terms.

*Correspondence: Fotis Psomopoulos, fpsom@certh.gr

These authors have contributed equally to this work

Disclaimer: All claims expressed in this article are solely those of the authors and do not necessarily represent those of their affiliated organizations, or those of the publisher, the editors and the reviewers. Any product that may be evaluated in this article or claim that may be made by its manufacturer is not guaranteed or endorsed by the publisher.