Contents

0.1 Introduction

The Barcode, UMI, Set (BUS) format is a new way to represent pseudoalignments of reads from RNA-seq. Files of this format can be efficiently generated by the command line tool kallisto bus. With kallisto bus and this package, we go from the fastq files to the sparse matrix used for downstream analysis such as with Seurat within half an hour, while Cell Ranger would take hours.

In this vignette, we convert an 10x 1:1 mouse and human cell mixture dataset from the BUS format to a sparse matrix. To see how the BUS format can be generated from fastq file, as well as more in depth vignettes, see the website of this package.

Note that this vignette is deprecated and is kept for historical reasons as it was implemented when kallisto | bustools was experimental. The functionality of make_sparse_matrix has been implemented more efficiently in the command line tool bustools. Please use the updated version of bustools and if you wish, the wrapper kb instead.

0.2 Download the dataset

# The dataset package
library(TENxBUSData)
library(BUSpaRse)
library(Matrix)
library(zeallot)
library(ggplot2)
TENxBUSData(".", dataset = "hgmm100")
#> see ?TENxBUSData and browseVignettes('TENxBUSData') for documentation
#> downloading 1 resources
#> retrieving 1 resource
#> loading from cache
#> The downloaded files are in /tmp/RtmpzoZjtL/Rbuild21973f7fcb6023/BUSpaRse/vignettes/out_hgmm100
#> [1] "/tmp/RtmpzoZjtL/Rbuild21973f7fcb6023/BUSpaRse/vignettes/out_hgmm100"

0.3 Convert to sparse matrix

First, we map transcripts, as in the kallisto index, to the corresponding genes.

tr2g <- transcript2gene(species = c("Homo sapiens", "Mus musculus"), type = "vertebrate",
                        kallisto_out_path = "./out_hgmm100", ensembl_version = 99,
                        write_tr2g = FALSE)
#> Querying biomart for transcript and gene IDs of Homo sapiens
#> Querying biomart for transcript and gene IDs of Mus musculus
head(tr2g)
#>          transcript              gene gene_name chromosome_name
#> 1 ENST00000434970.2 ENSG00000237235.2     TRDD2              14
#> 2 ENST00000415118.1 ENSG00000223997.1     TRDD1              14
#> 3 ENST00000448914.1 ENSG00000228985.1     TRDD3              14
#> 4 ENST00000632684.1 ENSG00000282431.1     TRBD1               7
#> 5 ENST00000390583.1 ENSG00000211923.1  IGHD3-10              14
#> 6 ENST00000431440.2 ENSG00000232543.2  IGHD4-11              14

Here we make both the gene count matrix and the TCC matrix.

c(gene_count, tcc) %<-% make_sparse_matrix("./out_hgmm100/output.sorted.txt",
                               tr2g = tr2g, est_ncells = 1e5,
                               est_ngenes = nrow(tr2g))
#> Reading matrix.ec
#> Processing ECs
#> Matching genes to ECs
#> Reading data
#> Constructing gene count matrix
#> Constructing TCC matrix

0.4 Remove empty droplets

Here we have a sparse matrix with genes in rows and cells in columns.

dim(gene_count)
#> [1]  26937 151449

This dataset should only have about 100 cells, but here we get over 100,000. In fact, most of the barcodes correspond to empty droplets; they can be removed by filtering out barcodes with too few UMI.

tot_counts <- Matrix::colSums(gene_count)
summary(tot_counts)
#>     Min.  1st Qu.   Median     Mean  3rd Qu.     Max. 
#>     1.00     1.00     2.00    24.77     5.00 64041.00
df1 <- get_knee_df(gene_count)
infl1 <- get_inflection(df1)
knee_plot(df1, infl1)

gene_count <- gene_count[, tot_counts > infl1]
dim(gene_count)
#> [1] 26937   122

Then this sparse matrix can be used in Seurat for downstream analysis.

Likewise, we can remove empty droplets from the TCC matrix.

dim(tcc)
#> [1] 129371 157659

This dataset should only have about 100 cells, but here we get over 100,000. In fact, most of the barcodes correspond to empty droplets; they can be removed by filtering out barcodes with too few UMI.

tot_counts <- Matrix::colSums(tcc)
summary(tot_counts)
#>     Min.  1st Qu.   Median     Mean  3rd Qu.     Max. 
#>     1.00     1.00     2.00    25.84     5.00 69235.00
df2 <- get_knee_df(tcc)
infl2 <- get_inflection(df2)
knee_plot(df2, infl2)

tcc <- tcc[, tot_counts > infl2]
dim(tcc)
#> [1] 129371    121
sessionInfo()
#> R Under development (unstable) (2024-03-18 r86148)
#> Platform: x86_64-pc-linux-gnu
#> Running under: Ubuntu 22.04.4 LTS
#> 
#> Matrix products: default
#> BLAS:   /home/biocbuild/bbs-3.19-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_US.UTF-8        LC_COLLATE=en_US.UTF-8    
#>  [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] ggplot2_3.5.0      zeallot_0.1.0      Matrix_1.6-5       BUSpaRse_1.17.2   
#> [5] TENxBUSData_1.17.0 BiocStyle_2.31.0  
#> 
#> loaded via a namespace (and not attached):
#>   [1] DBI_1.2.2                   bitops_1.0-7               
#>   [3] httr2_1.0.0                 biomaRt_2.59.1             
#>   [5] rlang_1.1.3                 magrittr_2.0.3             
#>   [7] matrixStats_1.2.0           compiler_4.4.0             
#>   [9] RSQLite_2.3.5               GenomicFeatures_1.55.4     
#>  [11] png_0.1-8                   vctrs_0.6.5                
#>  [13] stringr_1.5.1               ProtGenerics_1.35.4        
#>  [15] pkgconfig_2.0.3             crayon_1.5.2               
#>  [17] fastmap_1.1.1               magick_2.8.3               
#>  [19] dbplyr_2.5.0                XVector_0.43.1             
#>  [21] utf8_1.2.4                  Rsamtools_2.19.4           
#>  [23] rmarkdown_2.26              purrr_1.0.2                
#>  [25] bit_4.0.5                   xfun_0.42                  
#>  [27] zlibbioc_1.49.3             cachem_1.0.8               
#>  [29] GenomeInfoDb_1.39.9         jsonlite_1.8.8             
#>  [31] progress_1.2.3              blob_1.2.4                 
#>  [33] highr_0.10                  DelayedArray_0.29.9        
#>  [35] BiocParallel_1.37.1         parallel_4.4.0             
#>  [37] prettyunits_1.2.0           plyranges_1.23.0           
#>  [39] R6_2.5.1                    bslib_0.6.1                
#>  [41] stringi_1.8.3               rtracklayer_1.63.1         
#>  [43] GenomicRanges_1.55.4        jquerylib_0.1.4            
#>  [45] Rcpp_1.0.12                 bookdown_0.38              
#>  [47] SummarizedExperiment_1.33.3 knitr_1.45                 
#>  [49] IRanges_2.37.1              tidyselect_1.2.1           
#>  [51] abind_1.4-5                 yaml_2.3.8                 
#>  [53] codetools_0.2-19            curl_5.2.1                 
#>  [55] lattice_0.22-5              tibble_3.2.1               
#>  [57] withr_3.0.0                 Biobase_2.63.0             
#>  [59] KEGGREST_1.43.0             evaluate_0.23              
#>  [61] BiocFileCache_2.11.1        xml2_1.3.6                 
#>  [63] ExperimentHub_2.11.1        Biostrings_2.71.4          
#>  [65] pillar_1.9.0                BiocManager_1.30.22        
#>  [67] filelock_1.0.3              MatrixGenerics_1.15.0      
#>  [69] stats4_4.4.0                generics_0.1.3             
#>  [71] RCurl_1.98-1.14             BiocVersion_3.19.1         
#>  [73] ensembldb_2.27.1            S4Vectors_0.41.4           
#>  [75] hms_1.1.3                   munsell_0.5.0              
#>  [77] scales_1.3.0                glue_1.7.0                 
#>  [79] lazyeval_0.2.2              tools_4.4.0                
#>  [81] AnnotationHub_3.11.3        BiocIO_1.13.0              
#>  [83] BSgenome_1.71.2             GenomicAlignments_1.39.4   
#>  [85] XML_3.99-0.16.1             grid_4.4.0                 
#>  [87] tidyr_1.3.1                 AnnotationDbi_1.65.2       
#>  [89] colorspace_2.1-0            GenomeInfoDbData_1.2.11    
#>  [91] restfulr_0.0.15             cli_3.6.2                  
#>  [93] rappdirs_0.3.3              fansi_1.0.6                
#>  [95] S4Arrays_1.3.6              dplyr_1.1.4                
#>  [97] AnnotationFilter_1.27.0     gtable_0.3.4               
#>  [99] sass_0.4.9                  digest_0.6.35              
#> [101] BiocGenerics_0.49.1         SparseArray_1.3.4          
#> [103] farver_2.1.1                rjson_0.2.21               
#> [105] memoise_2.0.1               htmltools_0.5.7            
#> [107] lifecycle_1.0.4             httr_1.4.7                 
#> [109] mime_0.12                   bit64_4.0.5