Contents

1 FLAMES

The FLAMES package provides a framework for performing single-cell and bulk read full-length analysis of mutations and splicing. FLAMES performs cell barcode and UMI assignment from nanopore reads as well as semi-supervised isoform detection and quantification. FLAMES is designed to be an easy and quick to use, powerful workflow for isoform detection and quantification, splicing analysis and mutation detection, and seeks to overcome the limitations of other tools, such as an inability to process single cell data, and a focus on cell barcode and UMI assignment (Tian et al. 2020).

This R package represents an enhanced iteration of the FLAMES Python module that originally designed to support the research work presented in Comprehensive characterization of single-cell full-length isoforms in human and mouse with long-read sequencing by Tian et al (2020). This upgraded R version not only simplifies the installation and execution processes but also incorporates additional functionality, streamlining the analysis of single-cell full-length isoforms using long-read sequencing data.

FLAMES pipeline workflow summary

Figure 1: FLAMES pipeline workflow summary

When processing single cell data, FLAEMS can be run on data generated from long-read platform with or without matched short-read sequencing data. If only the long reads are available, FLAMES takes as input the long reads in fastq files. The blaze() function is then called to demultiplex the long reads into cell-specific fastq files. If the short-read data is available, FLAMES incorporates the BLAZE as blaze() function to identify cell barcodes solely from long reads (You et al. 2023). The blaze() function is called to locate the barcode sequencing in the long-reads, identify barcode allow-list directly from long reads, assign reads to cells (i.e., demultiplexing) and trims the cell barcodes and the flanking UMI sequence.

When matched short-read single-cell RNA sequencing data is available, FLAMES could take the cell barcode allow-list generated from short reads in addition to the long-read fastq files. The short-read allow-list will used as a reference to guide the demultiplexing of the long reads. To do this, FLAMES incorporates the flexiplex as find_barcode() function to perform demultiplexing (Davidson et al. 2023). The find_barcode() function is called to extract the cell barcode and UMI sequence from the long reads, using the allow-list as a reference.

After the demultiplexing, the pipeline calls minimap_align(), a minimap2 wrapper, to align the demultiplex long-reads to the reference genome. quantify_gene() is then called to deduplicate reads from same unique molecular identifiers (UMIs) and generate gene-level UMI counts. Note that during the UMI deduplication, the pipeline only keeps the longest reads among those with the same UMI for downstream steps.

Next, find_isoform() is called to identify novel isoforms using the alignment, creating an updated transcript assembly. In this step, the users may choose to use bambu, which is designed for transcript discovery and quantification using long read RNA-Seq data (???). Otherwise, users could use the build-in isoform identification methods in FLAMES. Both methods have been wrapped in the find_isoform() function.

Afterwards, the demultiplexed reads are aligned to the transcript assembly by the function minimap_realign(). Finally, FLAMES calls quantify_transcript() to quantify the transcript counts using the (re-)alignment file.

Figure 1 summerise the steps of the pipeline described above. The pipeline functions (sc_long_pipeline, bulk_long_pipeline, sc_long_multisample_pipline) execute the steps sequentially and return SingleCellExperiment object, SummarizedExperiment object and a list of SingleCellExperiment objects respectivly.

For read alignment and realignment, FLAMES uses minimap2, a versatile alignment program for aligning sequences against a reference database (Li 2018). This software needs to be downloaded prior to using the FLAMES pipeline, and can be found at https://github.com/lh3/minimap2.

2 FLAMES Pipeline Execution

This vignette will detail the process of running the FLAMES pipeline. It details the execution of both the single cell pipeline (sc_long_pipeline()) and the bulk data pipeline (bulk_long_pipeline()).

2.1 FLAMES Single Cell Pipeline

2.1.1 Environment setup

To get started, the pipeline needs access to a gene annotation file in GFF3 or GTF format, a directory containing one or more FASTQ files (which will be merged as pre-processing), a genome FASTA file, as well as the file path to minimap2, and the file path to the directory to hold output files.

The single cell pipeline can demultiplex the input data before running, if required. This can be disabled by setting the do_barcode_demultiplex argument in the config file to FALSE when calling the pipeline. This example dataset has already been demultiplexed.

For this example, the required files are downloaded from GitHub using BiocFileCache (Shepherd and Morgan 2021).

temp_path <- tempfile()
bfc <- BiocFileCache::BiocFileCache(temp_path, ask = FALSE)

file_url <-
  "https://raw.githubusercontent.com/OliverVoogd/FLAMESData/master/data"

annot <- bfc[[names(BiocFileCache::bfcadd(
  bfc, "Annotation",
  file.path(file_url, "gencodeshortened.gtf")
))]]

genome_fa <- bfc[[names(BiocFileCache::bfcadd(
  bfc,
  "Genomefa",
  file.path(file_url, "GRCh38shortened.fa")
))]]

fastq <- bfc[[names(BiocFileCache::bfcadd(
  bfc, "Fastq", file.path(file_url, "sc_align2genome.sample.fastq.gz")))]]

# setup other environment variables
outdir <- tempfile()
dir.create(outdir)
config_file <- FLAMES::create_config(outdir, type = "SIRV", do_barcode_demultiplex = TRUE)
#> Registered S3 method overwritten by 'GGally':
#>   method from   
#>   +.gg   ggplot2
#> Writing configuration parameters to:  /tmp/Rtmpcdq7Gp/file26d318169e5bed/config_file_2544408.json

The optional argument config_file can be given to both bulk_long_pipeline() and sc_long_pipeline() in order to customise the execution of the pipelines. It is expected to be a JSON file, and an example can be found by calling FLAMES::create_config, which returns the path to a copy of the default JSON configuration file. The values from the default configs can be altered by either editing the JSON file manually, or passing additional arguments to FLAMES::create_config, for example, FLAMES::create_config(outdir, type = "sc_3end", min_sup_cnt = 10) with create a copy of the default config for 10X 3’ end nanopore single cell reads, with the min_sup_cnt value (minimal number of supporting reads for a novel isoform to pass filtering) changed to 10.

This vignette uses the default configuration file created for SIRV reads.

2.1.2 FLAMES execution

Once the initial variables have been setup, the pipeline can be run using:

library(FLAMES)
# do not run if minimap2 cannot be found
if (is.character(locate_minimap2_dir())) { 
  sce <- sc_long_pipeline(
    annotation = annot, fastq = fastq, genome_fa = genome_fa,
    outdir = outdir, config_file = config_file, expect_cell_number = 10)
}

If, however, the input fastq files need to be demultiplexed, then the reference_csv argument will need to be specified - reference_csv is the file path to a cell barcode allow-list, as a text file with one barcode per line. The filtered_feature_bc_matrix/barcodes.tsv.gz from cellranger outputs can be used to create such allow-list, with zcat barcodes.tsv.gz | cut -f1 -d'-' > allow-list.csv.

The pipeline can alse be run by calling the consituent steps sequentially:

library(FLAMES)
minimap2_dir <- locate_minimap2_dir()
if (is.character(minimap2_dir)) { # do not run if minimap2 cannot be found
  config <- jsonlite::fromJSON(config_file)
  # find_barcode(...)
  genome_bam <- rownames(minimap2_align(
    config = config, fa_file = genome_fa, fq_in = fastq, annot = annot,
    outdir = outdir, minimap2_dir = minimap2_dir
  ))
  find_isoform(
    annotation = annot, genome_fa = genome_fa,
    genome_bam = genome_bam, outdir = outdir, config = config
  )
  minimap2_realign(
    config = config, fq_in = fastq,
    outdir = outdir, minimap2_dir = minimap2_dir
  )
  quantify_transcript(annotation = annot, outdir = outdir, config = config)
  sce <- create_sce_from_dir(outdir = outdir, annotation = annot)
}

2.2 Visulisation

The combine_sce() and sc_annotate_plots() can be used for visulisation with experiment designs similar to FLT-seq. The combine_sce() function combines the SingleCellExperiment objects of 1) the short-read gene counts from the larger subsample, 2) the short-read gene counts from the smaller subsample and 3) the transcript counts from the larger subsample into a MultiAssayExperiment object. The sc_annotate_plots() function can then use it to produce annotated plots.

library(FLAMES)
library(MultiAssayExperiment)

combined_sce <- combine_sce(
    short_read_large = scmixology_lib90,
    short_read_small = scmixology_lib10,
    long_read_sce = scmixology_lib10_transcripts,
    remove_duplicates = FALSE) |>
  sc_reduce_dims(n_pcs = 20, n_hvgs = 1000)

sc_umap_expression(gene = "ENSG00000108107", multiAssay = combined_sce)
sc_heatmap_expression(gene = "ENSG00000108107", multiAssay = combined_sce)

scater::plotReducedDim(
    experiments(combined_sce)$gene_counts,
    dimred = "PCA",
    colour_by = colData(combined_sce
        [,,"gene_counts"])[,"Lib_small",drop=FALSE])

2.2.1 FLAMES termination

The directory outdir now contains several output files returned from this pipeline. The output files generated by this pipeline are:

  • transcript_count.csv.gz - a transcript count matrix (also contained in the output SummarizedExperiment or SingleCellExperiment)
  • isoform_annotated.filtered.gff3 - found isoform information in gff3 format
  • transcript_assembly.fa - transcript sequence from the isoforms
  • align2genome.bam sorted BAM file with reads aligned to genome (intermediate FLAMES step)
  • realign2transcript.bam - sorted realigned BAM file using the transcript_assembly.fa as reference (intermediate FLAMES step)
  • tss_tes.bedgraph- TSS TES enrichment for all reads (for QC)

The pipeline also returns a SummarizedExperiment or SingleCellExperiment object, depending on the pipeline run, containing the data from transcript_count.csv.gzand isoform_annotated.filtered.gff3 (Amezquita et al. 2020) (Morgan et al. 2020). This SummarizedExperiment (or SingleCellExperiment) object contains the same data as present in the outdir directory, and is given to simplify the process of reading the transcript count matrix and annotation data back into R, for further analysis.

2.3 FLAMES Bulk Pipeline

A basic example of the execution of the FLAMES bulk pipeline is given below. The process for this is essentially identical to the above example for single cell data.

2.3.1 Environment setup

To get started, the pipeline needs access to a gene annotation file in GFF3 or GTF format, a directory containing one or more FASTQ files (which will be merged as pre-processing), a genome FASTA file, as well as the file path to minimap2, and the file path to the directory to hold output files.

For this example, these files are downloaded from GitHub using BiocFileCache (Shepherd and Morgan 2021).

temp_path <- tempfile()
bfc <- BiocFileCache::BiocFileCache(temp_path, ask = FALSE)

file_url <-
  "https://raw.githubusercontent.com/OliverVoogd/FLAMESData/master/data"

annot <- bfc[[names(BiocFileCache::bfcadd(
  bfc, "Annotation",
  file.path(file_url, "SIRV_isoforms_multi-fasta-annotation_C_170612a.gtf")
))]]

genome_fa <- bfc[[names(BiocFileCache::bfcadd(
  bfc, "Genomefa",
  file.path(file_url, "SIRV_isoforms_multi-fasta_170612a.fasta")
))]]

# download the two fastq files, move them to a folder to be merged together
fastq1 <- bfc[[names(BiocFileCache::bfcadd(bfc, "Fastq1", 
                file.path(file_url, "fastq", "sample1.fastq.gz")))]]
fastq2 <- bfc[[names(BiocFileCache::bfcadd(bfc, "Fastq2",
                file.path(file_url, "fastq", "sample2.fastq.gz")))]]

# the downloaded fastq files need to be in a directory to be merged together
fastq_dir <- file.path(temp_path, "fastq_dir") 
dir.create(fastq_dir)
file.copy(c(fastq1, fastq2), fastq_dir)
#> [1] TRUE TRUE
unlink(c(fastq1, fastq2)) # the original files can be deleted

# setup other environment variables
outdir <- tempfile()
dir.create(outdir)
config_file <- FLAMES::create_config(outdir)
#> Writing configuration parameters to:  /tmp/Rtmpcdq7Gp/file26d3183317586f/config_file_2544408.json

2.3.2 FLAMES execution

Once the environment has been setup, the pipeline can be executed by running:

library(FLAMES)
if (is.character(locate_minimap2_dir())) {
  summarizedExperiment <- bulk_long_pipeline(
    annot = annot, fastq = fastq_dir, outdir = outdir,
    genome_fa = genome_fa, minimap2_dir = minimap2_dir,
    config_file = config_file
  )
}

2.3.3 FLAMES termination

After the bulk pipeline has completed, the output directory contains the same files as the single cell pipeline produces. bulk_long_pipeline also returns a SummarizedExperiment object, containing the same data as the SingleCellExperiment as above (Amezquita et al. 2020) (Morgan et al. 2020).

2.4 Running with Slurm

Since the barcode demultiplexing step, isoform identification step and quantification step is currently single threaded, job scheduler (such as Slurm) users may want to allocate different resources for each step. This can be achieved by calling the individual functions (find_isoform, minimap2_realign etc.) sequentially, or by changing the configuration file. The Bash script below demonstrates how this can be done with a single R script calling the pipeline function.

#!/bin/bash -x

# set all steps to false
sed -i '/"do_/s/true/false/' config_sclr_nanopore_3end.json 
# set do_genome_alignment to true
sed -i '/do_genome_alignment/s/false/true/' \
        config_sclr_nanopore_3end.json 
srun -c 20 --mem 64GB \
        Rscript flames_pipeline.R && \

sed -i '/"do_/s/true/false/' \
        config_sclr_nanopore_3end.json && \
sed -i '/do_isoform_identification/s/false/true/' \
        config_sclr_nanopore_3end.json && \
srun -c 1 --mem 64GB --ntasks=1 \
        Rscript flames_pipeline.R  && \

sed -i '/"do_/s/true/false/' \
        config_sclr_nanopore_3end.json && \
sed -i '/do_read_realignment/s/false/true/' \
        config_sclr_nanopore_3end.json && \
srun -c 20 --mem 64GB --ntasks=1 \
        Rscript flames_pipeline.R && \

sed -i '/"do_/s/true/false/' \
        config_sclr_nanopore_3end.json && \
sed -i '/do_transcript_quantification/s/false/true/' \
        config_sclr_nanopore_3end.json && \
srun -c 1 --mem 64GB --ntasks=1 \
        Rscript flames_pipeline.R && \

echo "Pipeline finished"

The Bash script can then be executed inside a tmux or screen session with:

./flames.sh | tee -a bash.log; tail bash.log \
        | mail -s "flames pipeline ended" user@example.com

2.5 FLAMES on Windows

Due to FLAMES requiring minimap2 and pysam, FLAMES is currently unavaliable on Windows.

2.6 Citation

Please cite flames’s paper if you use flames in your research. As FLAMES used incorporates BLAZE, flexiplex and minimap2, samtools, bambu. Please make sure to cite when using these tools.

3 Session Info

#> R version 4.3.1 (2023-06-16)
#> Platform: x86_64-pc-linux-gnu (64-bit)
#> Running under: Ubuntu 22.04.3 LTS
#> 
#> Matrix products: default
#> BLAS:   /home/biocbuild/bbs-3.18-bioc/R/lib/libRblas.so 
#> LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.10.0
#> 
#> locale:
#>  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
#>  [3] LC_TIME=en_GB              LC_COLLATE=C              
#>  [5] LC_MONETARY=en_US.UTF-8    LC_MESSAGES=en_US.UTF-8   
#>  [7] LC_PAPER=en_US.UTF-8       LC_NAME=C                 
#>  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
#> [11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C       
#> 
#> time zone: America/New_York
#> tzcode source: system (glibc)
#> 
#> attached base packages:
#> [1] stats     graphics  grDevices utils     datasets  methods   base     
#> 
#> other attached packages:
#> [1] BiocStyle_2.30.0
#> 
#> loaded via a namespace (and not attached):
#>   [1] BiocIO_1.12.0               bitops_1.0-7               
#>   [3] filelock_1.0.2              tibble_3.2.1               
#>   [5] R.oo_1.25.0                 basilisk.utils_1.14.0      
#>   [7] bambu_3.4.0                 graph_1.80.0               
#>   [9] XML_3.99-0.14               rpart_4.1.21               
#>  [11] lifecycle_1.0.3             edgeR_4.0.0                
#>  [13] doParallel_1.0.17           OrganismDbi_1.44.0         
#>  [15] ensembldb_2.26.0            globals_0.16.2             
#>  [17] lattice_0.22-5              MultiAssayExperiment_1.28.0
#>  [19] backports_1.4.1             magrittr_2.0.3             
#>  [21] limma_3.58.0                Hmisc_5.1-1                
#>  [23] sass_0.4.7                  rmarkdown_2.25             
#>  [25] jquerylib_0.1.4             yaml_2.3.7                 
#>  [27] metapod_1.10.0              reticulate_1.34.0          
#>  [29] ggbio_1.50.0                cowplot_1.1.1              
#>  [31] DBI_1.1.3                   RColorBrewer_1.1-3         
#>  [33] abind_1.4-5                 zlibbioc_1.48.0            
#>  [35] GenomicRanges_1.54.0        purrr_1.0.2                
#>  [37] R.utils_2.12.2              AnnotationFilter_1.26.0    
#>  [39] biovizBase_1.50.0           BiocGenerics_0.48.0        
#>  [41] RCurl_1.98-1.12             nnet_7.3-19                
#>  [43] VariantAnnotation_1.48.0    rappdirs_0.3.3             
#>  [45] circlize_0.4.15             GenomeInfoDbData_1.2.11    
#>  [47] IRanges_2.36.0              S4Vectors_0.40.0           
#>  [49] ggrepel_0.9.4               irlba_2.3.5.1              
#>  [51] listenv_0.9.0               dqrng_0.3.1                
#>  [53] parallelly_1.36.0           DelayedMatrixStats_1.24.0  
#>  [55] codetools_0.2-19            DropletUtils_1.22.0        
#>  [57] DelayedArray_0.28.0         scuttle_1.12.0             
#>  [59] xml2_1.3.5                  tidyselect_1.2.0           
#>  [61] shape_1.4.6                 viridis_0.6.4              
#>  [63] ScaledMatrix_1.10.0         matrixStats_1.0.0          
#>  [65] stats4_4.3.1                BiocFileCache_2.10.0       
#>  [67] base64enc_0.1-3             GenomicAlignments_1.38.0   
#>  [69] FLAMES_1.8.0                jsonlite_1.8.7             
#>  [71] BiocNeighbors_1.20.0        GetoptLong_1.0.5           
#>  [73] Formula_1.2-5               scater_1.30.0              
#>  [75] iterators_1.0.14            foreach_1.5.2              
#>  [77] tools_4.3.1                 progress_1.2.2             
#>  [79] Rcpp_1.0.11                 glue_1.6.2                 
#>  [81] gridExtra_2.3               SparseArray_1.2.0          
#>  [83] xfun_0.40                   MatrixGenerics_1.14.0      
#>  [85] GenomeInfoDb_1.38.0         dplyr_1.1.3                
#>  [87] HDF5Array_1.30.0            withr_2.5.1                
#>  [89] BiocManager_1.30.22         fastmap_1.1.1              
#>  [91] GGally_2.1.2                basilisk_1.14.0            
#>  [93] bluster_1.12.0              rhdf5filters_1.14.0        
#>  [95] fansi_1.0.5                 rsvd_1.0.5                 
#>  [97] digest_0.6.33               R6_2.5.1                   
#>  [99] colorspace_2.1-0            dichromat_2.0-0.1          
#> [101] biomaRt_2.58.0              RSQLite_2.3.1              
#> [103] R.methodsS3_1.8.2           utf8_1.2.4                 
#> [105] tidyr_1.3.0                 generics_0.1.3             
#> [107] data.table_1.14.8           rtracklayer_1.62.0         
#> [109] prettyunits_1.2.0           httr_1.4.7                 
#> [111] htmlwidgets_1.6.2           S4Arrays_1.2.0             
#> [113] pkgconfig_2.0.3             gtable_0.3.4               
#> [115] blob_1.2.4                  ComplexHeatmap_2.18.0      
#> [117] SingleCellExperiment_1.24.0 XVector_0.42.0             
#> [119] htmltools_0.5.6.1           bookdown_0.36              
#> [121] RBGL_1.78.0                 ProtGenerics_1.34.0        
#> [123] clue_0.3-65                 scales_1.2.1               
#> [125] Biobase_2.62.0              png_0.1-8                  
#> [127] scran_1.30.0                knitr_1.44                 
#> [129] rstudioapi_0.15.0           reshape2_1.4.4             
#> [131] rjson_0.2.21                checkmate_2.2.0            
#> [133] curl_5.1.0                  cachem_1.0.8               
#> [135] rhdf5_2.46.0                GlobalOptions_0.1.2        
#> [137] stringr_1.5.0               vipor_0.4.5                
#> [139] parallel_4.3.1              foreign_0.8-85             
#> [141] AnnotationDbi_1.64.0        restfulr_0.0.15            
#> [143] pillar_1.9.0                grid_4.3.1                 
#> [145] reshape_0.8.9               vctrs_0.6.4                
#> [147] BiocSingular_1.18.0         dbplyr_2.3.4               
#> [149] beachmat_2.18.0             cluster_2.1.4              
#> [151] beeswarm_0.4.0              htmlTable_2.4.1            
#> [153] evaluate_0.22               GenomicFeatures_1.54.0     
#> [155] cli_3.6.1                   locfit_1.5-9.8             
#> [157] compiler_4.3.1              Rsamtools_2.18.0           
#> [159] rlang_1.1.1                 crayon_1.5.2               
#> [161] ggbeeswarm_0.7.2            plyr_1.8.9                 
#> [163] stringi_1.7.12              viridisLite_0.4.2          
#> [165] BiocParallel_1.36.0         munsell_0.5.0              
#> [167] Biostrings_2.70.0           lazyeval_0.2.2             
#> [169] Matrix_1.6-1.1              dir.expiry_1.10.0          
#> [171] BSgenome_1.70.0             hms_1.1.3                  
#> [173] sparseMatrixStats_1.14.0    bit64_4.0.5                
#> [175] future_1.33.0               ggplot2_3.4.4              
#> [177] Rhdf5lib_1.24.0             KEGGREST_1.42.0            
#> [179] statmod_1.5.0               SummarizedExperiment_1.32.0
#> [181] igraph_1.5.1                memoise_2.0.1              
#> [183] bslib_0.5.1                 bit_4.0.5                  
#> [185] xgboost_1.7.5.1

References

Amezquita, Robert, Aaron Lun, Etienne Becht, Vince Carey, Lindsay Carpp, Ludwig Geistlinger, Federico Marini, et al. 2020. “Orchestrating Single-Cell Analysis with Bioconductor.” Nature Methods 17: 137–45. https://www.nature.com/articles/s41592-019-0654-x.

Davidson, Nadia M, Noorul Amin, Ling Min Hao, Changqing Wang, Oliver Cheng, Jonathan M Goeke, Matthew E Ritchie, and Shuyi Wu. 2023. “Flexiplex: A Versatile Demultiplexer and Search Tool for Omics Data.” bioRxiv, 2023–08.

Li, Heng. 2018. “Minimap2: pairwise alignment for nucleotide sequences.” Bioinformatics 34 (18): 3094–3100. https://doi.org/10.1093/bioinformatics/bty191.

Morgan, Martin, Valerie Obenchain, Jim Hester, and Hervé Pagès. 2020. SummarizedExperiment: SummarizedExperiment Container. https://bioconductor.org/packages/SummarizedExperiment.

Shepherd, Lori, and Martin Morgan. 2021. BiocFileCache: Manage Files Across Sessions.

Tian, Luyi, Jafar S. Jabbari, Rachel Thijssen, Quentin Gouil, Shanika L. Amarasinghe, Hasaru Kariyawasam, Shian Su, et al. 2020. “Comprehensive Characterization of Single Cell Full-Length Isoforms in Human and Mouse with Long-Read Sequencing.” bioRxiv. https://doi.org/10.1101/2020.08.10.243543.

You, Yupei, Yair DJ Prawer, De Paoli-Iseppi, Cameron PJ Hunt, Clare L Parish, Heejung Shim, Michael B Clark, and others. 2023. “Identification of Cell Barcodes from Long-Read Single-Cell Rna-Seq with Blaze.” Genome Biology 24 (1): 1–23.