Abstract
Motivation
The process of analyzing high throughput sequencing data often requires the identification and extraction of specific target sequences. This could include tasks, such as identifying cellular barcodes and UMIs in single-cell data, and specific genetic variants for genotyping. However, existing tools, which perform these functions are often task-specific, such as only demultiplexing barcodes for a dedicated type of experiment, or are not tolerant to noise in the sequencing data.
Results
To overcome these limitations, we developed Flexiplex, a versatile and fast sequence searching and demultiplexing tool for omics data, which is based on the Levenshtein distance and thus allows imperfect matches. We demonstrate Flexiplex’s application on three use cases, identifying cell-line-specific sequences in Illumina short-read single-cell data, and discovering and demultiplexing cellular barcodes from noisy long-read single-cell RNA-seq data. We show that Flexiplex achieves an excellent balance of accuracy and computational efficiency compared to leading task-specific tools.
Availability and implementation
Flexiplex is available at https://davidsongroup.github.io/flexiplex/.
1 Introduction
High throughput sequencing, from both short- and long-read sequencing technologies, enable the genome, transcriptome, and other “omics” to be profiled by reading up to billions of nucleotides. Matching and extracting sequences from “omics” data are common analysis tasks. For example, searching for the presence of genetic variants or motifs, or identifying and error correcting barcodes. Highly efficient string search command-line tools, such as grep and agrep (Wu and Manber 1992), which find exact and approximate matches, respectively, have been used for this purpose in the past (Panagopoulos et al. 2014). However, they are designed for a small set of search patterns, and do not output the data in a format compatible with downstream analysis tools, thereby limiting their use for demultiplexing. Demultiplexing is becoming increasingly routine in “omics” data analysis. For instance, indexes, including barcodes and Unified Molecular Identifiers (UMIs), are added for a range of purposes, such as pooling samples to save sequencing cost, measuring clonal expansion, labeling reads from individual cells, or individual molecules (Smith et al. 2010, Merino et al. 2019, Bramlett et al. 2020, Philpott et al. 2021). To address this, demultiplexing tools have been built such as ultraplex (Wilkins et al. 2021) for short-read data, and scTagger (Ebrahimi et al. 2022) and BLAZE (You et al. 2023) for noisy long-read data. Some demultiplexing tools have also been built into multi-purpose pipelines, such as FLAMES (Tian et al. 2021), wf-single-cell (https://github.com/epi2me-labs/wf-single-cell), and SiCeLoRe (Lebrigand et al. 2020). However, these tools are often tailored to a specific experiment type, and may not work on a wider range of customized barcodes and sequencing data, specifically, when the structure of the barcode, flanking sequences, and their locations differ from the usual specifications. For this reason, experiment-agnostic tools have begun to be developed (Sullivan and Pachter 2023).
Long-read demultiplexing is a particular challenge, as the reads often contain a high number of errors, including insertions and deletions (Dohm et al. 2020). Moreover, a small percent of reads may be chimeric (White et al. 2017), containing multiple barcodes and requiring the read to be split. Although there are some tools, which can simultaneously split chimeric reads and demultiplex, such as poreChop (https://github. com/rrwick), these may not work across a broad range of datasets or when there are thousands of barcodes. Finally, much of the available software is complex to setup and install and their computational requirements in terms of time and memory can limit their practical use when processing the volumes of data now being generated.
Here, we introduce Flexiplex, which given a set of reads as either FASTQ or FASTA, will demultiplex and/or identify a sequence of interest, reporting matching reads and read-barcode assignment. Flexiplex works in two modes: (i) when one or more sequences of interest are known, such as barcodes, and (ii) discovery mode—when only the sequence which flanks the region of interest is known. Flexiplex is lightweight, multithreaded, fast, and easy to install and run. The source code and pre-built binary executables for Linux and MacOS are provided at https://davidsongroup.github.io/flexiplex/.
2 Flexiplex’s approach
Flexiplex assumes a read structure, where a barcode and UMI are flanked by other known sequences (Fig. 1A). To identify the barcode, Flexiplex first uses the edlib C++ library (Šošić and Šikić 2017) to search for the left and/or right flanking sequence. Default sequences are 22 bp from the 10x Genomics Chemistry v3 primer and 9 bp of poly T sequence. The intermediate sequence, which contains the barcode and UMI, is initially left as a wildcard (default length of 28 bp). For the best match to the flanking sequence within a specified edit distance (default edit distance of eight), the intermediate sequence (barcode and UMI) +/− 5 bp either side is extracted. Next, we align the extracted sequence against a user-provided list of known barcodes and calculate the Levenshtein distance (Berger et al. 2021). For speed, this step is implemented in an efficient dynamic programming algorithm within Flexiplex, rather than edlib. The best matching barcode equal or less than a specified distance (default of two) is reported, but only if no other barcode has equal lowest distance. To identify and split chimeric reads, Flexiplex will repeat the flank and barcode search with the previously found barcode and flanking region masked out. This is repeated until no new barcodes are found in the read. Subsequently, the reverse complement of the unmasked read is searched using the same algorithm.
The flank and barcode sequences provided to Flexiplex are customizable, as is the length of the barcode and UMI, and their order. Flexiplex will output identified barcodes, UMIs, and trimmed reads by default. If the barcode, UMI, and right flank are left unspecified, Flexiplex can be used as a general searching tool and will identify any read containing the left flanking sequence within a user defined distance. As it can read and write to standard IO, the output of Flexiplex can be piped to another instance of Flexiplex for complex search and demultiplexing applications, such as extracting cell barcodes from all reads, which contain a genetic variant of interest.
Flexiplex can also be used to discover barcodes directly from the data. If no barcode list is provided, the sequence following the left flank is assumed as the barcode, and barcodes are reported, along with their frequencies. Flexiplex is provided with a Python script, flexiplex-filter, which generates a filtered barcode list based on knee plot frequencies and, optionally, a user-provided whitelist. Flexiplex-filter works by first using a rolling window to approximate the derivative of the knee plot curve for each barcode. The most negative derivative is then assumed as the inflection point, which becomes the cutoff point. A plot of the frequency distribution and inflection point can be generated for manual inspection and the search range customized if needed (Supplementary Fig. S1). The filtered barcodes can then be passed back into Flexiplex for error tolerant barcode demultiplexing of each read.
To illustrate the performance of Flexiplex, we considered several typical use cases; searching for specific sequences of interest in low error short-read data and discovering and demultiplexing single-cell RNA sequencing barcodes from noisy long-read data. In all instances, Flexiplex demonstrated an excellent balance between computational efficiency and accuracy. However, these use cases are not exhaustive. Flexiplex is versatile with a wide range of applications beyond the examples presented here, such as clonal tagging of single cells using barcoding approaches (Putri et al. 2023) and sample demultiplexing in bulk data.
3 Use cases
3.1 Fast and accurate sequence search
We first show Flexiplex is a reliable and general sequence searching tool using an Illumina short-read single-cell RNA-Seq dataset from Chen et al. (2021). These data were generated from a mixture of seven cell lines including MCF-7, which is known to harbor the highly expressed fusion gene BCAS4-BCAS3 (Edgren et al. 2011, Davidson et al. 2015). The pool also included the HEK293T cell line, which expresses E1A, an Adenovirus 5 gene and the T47D cell line, which contains a Single Nucleotide Variant (SNV), rs878887783, in the mitochondrial gene, MT-ND1. Here, we demonstrate how reads of interest can be extracted using a query sequence and then processed for downstream analysis; in this use case, identifying reads from BCAS4-BCAS3, Adenovirus E1A, and rs878887783, and using them to assign cells to their cell line of origin.
Using Flexiplex, we searched the reads for 34 bp from each of Adenovirus E1A and the dominant breakpoint of BCAS4-BCAS3, and 54 bp centered on rs878887783 within an edit distance of two. As BCAS4-BCAS3 has an MCF-7-specific SNV 13 bp from the breakpoint, we used two query sequences, one with the SNV and one with the reference allele. We compared these results against three alternative methods: grep, which looks for an exact match; and ugrep (https://github.com/Genivia/ugrep) and seqkit grep (Shen et al. 2016), both allow mismatches. Flexiplex processed ∼200 million reads in 24 min using a single thread per search (linux high-performance computer). The computational speed was slower than grep (which took 1–2 min), but significantly faster than the other mismatch tolerant methods, seqkit grep (∼190 min) and ugrep (∼40 min) (Supplementary Fig. S2).
To translate identified reads into a list of cells expressing the novel sequence, we extracted cellular barcodes (first 16 bp) from the pair of matched reads. The cells identified fell into clusters based on gene expression as expected (Fig. 1B), allowing us to assign clusters to cell lines and assess the performance of each tool. Flexiplex identified the highest or second highest number of cells expressing BCAS4-BCAS3 (365 of 956 cells), Adenovirus E1A (439 of 869 cells), and rs878887783 (515 of 987 cells) in the correct cluster (Fig. 1C). The importance of allowing mismatches was exemplified by BCAS4-BCAS3. When using the reference allele in our query sequence rather than the MCF-7-specific single nucleotide polymorphism (SNP), grep reported no matching reads, whereas Flexiplex identified 97% of those found using the MCF-7 variant (Fig. 1C).
False positives for BCAS4-BCAS3 and Adenovirus E1A, assessed by cells expressing the novel genes from other cell-line clusters, were at a similar rate for all tools. We hypothesize that the false positives are unlikely to be a result of poor sequence matching, but rather, a result of sequencing errors in the cellular barcodes, ambient RNA (Young and Behjati 2020) or barcode switching (Griffiths et al. 2018). To confirm this, we searched for the same variants in bulk RNA sequencing from three of the same cell lines and found no false positives for BCAS4-BCAS3 or Adenovirus E1A (Supplementary Table S1). For rs878887783, however, a large number of false positives were seen for ugrep and seqkit in both single cell (Fig. 1C and Supplementary Fig. S3) and bulk (Supplementary Table S1) data. These can be attributed to detection of the reference allele in other cell lines. As Flexiplex allows different error tolerance for different regions of the search sequence, it could require a perfect match for the 5 bp at the SNV while allowing up to two mismatches in the flanking region. Taken together, these results demonstrate that error tolerance improves sensitivity without compromising precision, even for low error Illumina data.
3.2 Demultiplexing cellular barcodes from noisy long-read data
Barcode demultiplexing is an application of sequence searching, where the number of query sequences (barcodes) can be large and the best match should be reported. We validated Flexiplex’s demultiplexing performance on noisy long-read Oxford Nanopore Technology (ONT) single-cell RNA sequencing. We compared Flexiplex’s performance with two specialized tools for long-read single-cell demultiplexing, scTagger and FLAMES, on simulated data generated by Ebrahimi et al. (2022). The simulation consisted of 5 million reads generated for 5000 cells. True barcode sequences were provided to each tool to benchmark them under a best-case scenario, where a perfect list of known barcodes is provided. Flexiplex reported the correct barcodes for more reads than any other methods across all maximum edit distances tested (0–3) and had the lowest false discovery rate (Fig. 1D).
Next, we verified these results on a real dataset, scmixology 2 from Tian et al. (2021). Scmixology 2 is a pool of five cell lines, which underwent FLT-Seq (Jabbari and Tian 2019), where cells were processed with the 10x Genomics 3’ v3 protocol followed by ONT long-read cDNA sequencing in addition to Illumina short-read sequencing. Approximately 25 million ONT reads were generated. Two hundred and forty-eight cells were identified in the matched short-read sequencing and their barcodes passed to the long-read demultiplexing tools.
To test the cellular barcode demultiplexing accuracy, we used two orthogonal methods to determine a read’s cell line of origin and assess their concordance. In the first method, cells had previously been annotated to cell lines using SNP-based clustering from matched short-reads (Tian et al. 2021). Reads could therefore be assigned to cell lines by correctly demultiplexing their cellular barcodes and looking up their associated cell line from the annotation. For a subset of reads, we could also determine the cell line using a second method, using cell-line-specific SNPs present in the reads (16 000 reads). For each of these SNP-typed reads, we assessed whether the predicted cell line from each approach matched (see Supplementary Methods for details), with the assumption that inconsistencies were predominantly caused by incorrect cellular barcodes.
We found that Flexiplex reported the highest number of reads where the cell lines were concordant, whilst <5% of reads had discordant cell lines (Fig. 1E). Importantly, we found that 3% of the reads in the dataset were chimeric, and Flexiplex’s ability to split these improved the demultiplexing performance further. Flexiplex took 2.6 h to process 25 million long reads (default settings, single thread, linux high-performance computer), which was slower than FLAMES (1.1 h), but faster than scTagger (2.9 h). Both Flexiplex and FLAMES consumed <1 GB of RAM, compared to 41 GB for scTagger (Supplementary Fig. S4).
Finally, we verified the performance of Flexiplex on a large PromethION dataset from You et al. (2023) of over 1000 human induced pluripotent stem cells (hiPSC) sequenced to a depth of 61 million reads. To emulate a typical 10x Genomics experiment, we passed each tool ∼11 000 cellular barcodes, where 1022 were true barcodes obtained from short-read data and the remaining 10 000 were decoys—randomly sampled from 10x Genomics’ list of possible cellular barcodes for v3. We then assessed the rates that true and decoy barcodes were reported (see Supplementary Methods) and found that Flexiplex was able to demultiplex the highest number of reads correctly, consistent with other analyses (Fig. 1F). Flexiplex completed in 7–14 h using 16 threads. scTagger was considerably faster, taking just 1.5–5 h, but required over 100 GB of RAM, compared to <1 GB for Flexiplex. FLAMES was unable to complete in a reasonable time due to being single threaded (<30% complete after 48 h), so was excluded from the comparison.
3.3 Discovering cellular barcode from noisy long-read data
Next, we assessed Flexiplex’s performance at barcode discovery, a scenario where the barcodes are unknown, and a list of valid barcodes need to be generated prior to demultiplexing with tools, such as those in the previous use case. This is one of the first analysis steps required for long-read single-cell sequencing without matched short-reads. We compared Flexiplex’s barcode discovery against the purpose-built tools scTagger, BLAZE, and ONT’s wf-single-cell on the scmixology 2 dataset, as well as three technical replicates (GridION Q20, GridION, and PromethION) of hiPSC sequenced with varying depths and error rates by You et al. (2023). The associated barcodes derived from short-read data were used as truth, but not provided to the tools. As scTagger does not estimate the number of cells using a knee plot method, we applied flexiplex-filter to the barcode frequencies from scTagger, to obtain the short-list for comparison. All tools were found to have similar sensitivity and specificity (Fig. 1G). However, we found that Flexiplex (four threads, other settings default, Linux high-performance computer) completed barcode discovery in ∼5%–16% of the time of BLAZE and 25%–42% of the time of scTagger (Fig. 1H). Relative performance was similar for other thread counts (Supplementary Table S2). While wf-single-cell is able to generate a barcode list, it is a complete Nextflow pipeline for single-cell data preprocessing, and will therefore perform tasks unrelated to barcode discovery. Hence, computational performance will exceed other tools and cannot be compared directly. For example, wf-single-cell (16 threads, up to 20 concurrent jobs) required memory and run-time an order of magnitude higher than Flexiplex (Supplementary Table S2).
4 Discussion
Here, we present Flexiplex, a generalized tool for sequence searching and demultiplexing. To achieve computational efficiency on large “omics” data, Flexiplex uses a combination of two Levenshtein distance alignment algorithms. Hence, Flexiplex is tolerant to substitutions, insertions, and deletions, which can be present in the data due to sequencing errors and SNPs. Flexiplex is highly customizable, including all search sequences and lengths, and whether to split chimeric reads, making it a versatile tool for many applications.
Using barcode discovery and demultiplexing of single-cell long-read RNA-Seq, and sequence searching in single-cell short-read RNA-Seq as use cases, we demonstrate that Flexiplex achieves accuracy comparable or exceeding popular task-specific tools, with good run-time and memory usage. However, Flexiplex’s applications are broader, and extend beyond single cell and RNA sequencing. For example, demultiplexing pooled samples generated by bulk long-read experiments, or custom clonal barcodes. Because Flexiplex can read and write to standard IO, instances of itself can be chained together on the command line for more complex tasks, e.g. to select reads with a mutation of interest and then demultiplex their cellular barcodes, or to search for phased variants or splicing. We designed Flexiplex to be a simple, user-friendly, and fast command line utility, with few dependencies, making it straightforward to install and run. It addresses the need for a lightweight tool to rapidly search and extract subsets of reads from raw data and can be easily integrated into comprehensive downstream data analysis pipelines.
Supplementary Material
Acknowledgements
We would like to acknowledge Alicia Oshlack for invaluable discussions and feedback on the manuscript. We would also like to thank Givanna Putri, Belinda Phipson and Edward Yang for testing Flexiplex and providing feedback, and Yupei You and Mike Clark for correspondence about their data and method.
Contributor Information
Oliver Cheng, Blood Cells and Blood Cancer Division, The Walter and Eliza Hall Institute of Medical Research, Parkville, VIC 3052, Australia; Bioinformatics Division, The Walter and Eliza Hall Institute of Medical Research, Parkville, VIC 3052, Australia; Faculty of Science, The University of Melbourne, Parkville, VIC 3010, Australia.
Min Hao Ling, Department for Epigenetic and Epitranscriptomic Regulation, Genome Institute of Singapore (GIS), Agency for Science, Technology and Research (A*STAR), Singapore 138672, Republic of Singapore.
Changqing Wang, Epigenetics and Development Division, The Walter and Eliza Hall Institute of Medical Research, Parkville, VIC 3052, Australia; Department of Medical Biology, Faculty of Medicine, Dentistry and Health Sciences, The University of Melbourne, Parkville, VIC 3010, Australia.
Shuyi Wu, Blood Cells and Blood Cancer Division, The Walter and Eliza Hall Institute of Medical Research, Parkville, VIC 3052, Australia; Bioinformatics Division, The Walter and Eliza Hall Institute of Medical Research, Parkville, VIC 3052, Australia; Faculty of Science, The University of Melbourne, Parkville, VIC 3010, Australia.
Matthew E Ritchie, Epigenetics and Development Division, The Walter and Eliza Hall Institute of Medical Research, Parkville, VIC 3052, Australia; Department of Medical Biology, Faculty of Medicine, Dentistry and Health Sciences, The University of Melbourne, Parkville, VIC 3010, Australia.
Jonathan Göke, Department for Epigenetic and Epitranscriptomic Regulation, Genome Institute of Singapore (GIS), Agency for Science, Technology and Research (A*STAR), Singapore 138672, Republic of Singapore; Department of Statistics and Data Science, National University of Singapore, Singapore 117546, Republic of Singapore.
Noorul Amin, Blood Cells and Blood Cancer Division, The Walter and Eliza Hall Institute of Medical Research, Parkville, VIC 3052, Australia; Bioinformatics Division, The Walter and Eliza Hall Institute of Medical Research, Parkville, VIC 3052, Australia; Department of Medical Biology, Faculty of Medicine, Dentistry and Health Sciences, The University of Melbourne, Parkville, VIC 3010, Australia.
Nadia M Davidson, Blood Cells and Blood Cancer Division, The Walter and Eliza Hall Institute of Medical Research, Parkville, VIC 3052, Australia; Bioinformatics Division, The Walter and Eliza Hall Institute of Medical Research, Parkville, VIC 3052, Australia; Department of Medical Biology, Faculty of Medicine, Dentistry and Health Sciences, The University of Melbourne, Parkville, VIC 3010, Australia.
Supplementary data
Supplementary data are available at Bioinformatics online.
Conflict of interest
None declared.
Funding
This work was supported by NHMRC Investigator Grant [GNT2016547 to N.M.D.].
Data availability
The data underlying this article are available in the Sequence Read Archive (SRA) under accession SRR10971813, and the European Nucleotide Archive (ENA) under accessions SAMEA110357667 and PRJEB54718.
References
- Berger B, Waterman MS, Yu YW. et al. Levenshtein distance, sequence comparison and biological database search. IEEE Trans Inf Theory 2021;67:3287–94. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Bramlett C, Jiang D, Nogalska A. et al. Clonal tracking using embedded viral barcoding and high-throughput sequencing. Nat Protoc 2020;15:1436–58. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Chen F, Ding K, Priedigkeit N. et al. Single-cell transcriptomic heterogeneity in invasive ductal and lobular breast cancer cells. Cancer Res 2021;81:268–81. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Davidson NM, Majewski IJ, Oshlack A. et al. JAFFA: high sensitivity transcriptome-focused fusion gene detection. Genome Med 2015;7:43. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Dohm JC, Peters P, Stralis-Pavese N. et al. Benchmarking of long-read correction methods. NAR Genom Bioinform 2020;2:lqaa037. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Ebrahimi G, Orabi B, Robinson M. et al. Fast and accurate matching of cellular barcodes across short-reads and long-reads of single-cell RNA-seq experiments. iScience 2022;25:104530. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Edgren H, Murumagi A, Kangaspeska S. et al. Identification of fusion genes in breast cancer by paired-end RNA-sequencing. Genome Biol 2011;12:R6. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Griffiths JA, Richard AC, Bach K. et al. Detection and removal of barcode swapping in single-cell RNA-seq data. Nat Commun 2018;9:2667. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Jabbari JS, Tian L. Massively parallel long-read sequencing of single cell RNA isoforms v1 (protocols.io.8d9hs96) 2019. https://www.protocols.io/view/massively-parallel-long-read-sequencing-of-single-81wgbpp1nvpk/v1.
- Lebrigand K, Magnone V, Barbry P. et al. High throughput error corrected nanopore single cell transcriptome sequencing. Nat Commun 2020;11:4025. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Merino D, Weber TS, Serrano A. et al. Barcoding reveals complex clonal behavior in patient-derived xenografts of metastatic triple negative breast cancer. Nat Commun 2019;10:766. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Panagopoulos I, Gorunova L, Bjerkehagen B. et al. The ‘grep’ command but not FusionMap, FusionFinder or ChimeraScan captures the CIC-DUX4 fusion gene from whole transcriptome sequencing data on a small round cell tumor with t(4;19)(q35;q13). PLoS One 2014;9:e99439. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Philpott M, Watson J, Thakurta A. et al. Nanopore sequencing of single-cell transcriptomes with scCOLOR-seq. Nat Biotechnol 2021;39:1517–20. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Putri GH, Pires N, Davidson NM. et al. Extraction and quantification of lineage-tracing barcodes with NextClone and CloneDetective. bioRxiv, 2023.11.19.567755, 2023, preprint: not peer reviewed.
- Shen W, Le S, Li Y. et al. SeqKit: a cross-platform and ultrafast toolkit for FASTA/Q file manipulation. PLoS One 2016;11:e0163962. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Smith AM, Heisler LE, St Onge RP. et al. Highly-multiplexed barcode sequencing: an efficient method for parallel analysis of pooled samples. Nucleic Acids Res 2010;38:e142. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Šošić M, Šikić M.. Edlib: a C/C++ library for fast, exact sequence alignment using edit distance. Bioinformatics 2017;33:1394–5. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Sullivan DK, Pachter L. Flexible parsing and preprocessing of technical sequences with splitcode. bioRxiv, 2023.03.20.533521, 2023, preprint: not peer reviewed. [DOI] [PMC free article] [PubMed]
- Tian L, Jabbari JS, Thijssen R. et al. Comprehensive characterization of single-cell full-length isoforms in human and mouse with long-read sequencing. Genome Biol 2021;22:310. [DOI] [PMC free article] [PubMed] [Google Scholar]
- White R, Pellefigues C, Ronchese F. et al. Investigation of chimeric reads using the MinION. F1000Res 2017;6:631. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Wilkins OG, Capitanchik C, Luscombe NM. et al. Ultraplex: a rapid, flexible, all-in-one fastq demultiplexer. Wellcome Open Res 2021;6:141. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Wu S, Manber U. Agrep–a fast approximate pattern-matching tool. In: Winter USENIX Conference, San Francisco, California. 1992.
- You Y, Prawer YDJ, De Paoli-Iseppi R. et al. Identification of cell barcodes from long-read single-cell RNA-seq with BLAZE. Genome Biol 2023;24:66. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Young MD, Behjati S.. SoupX removes ambient RNA contamination from droplet-based single-cell RNA sequencing data. Gigascience 2020;9:giaa151. [DOI] [PMC free article] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.
Supplementary Materials
Data Availability Statement
The data underlying this article are available in the Sequence Read Archive (SRA) under accession SRR10971813, and the European Nucleotide Archive (ENA) under accessions SAMEA110357667 and PRJEB54718.