Inputs and Outputs

Alexander Dietrich

library(Seurat)
#> Loading required package: SeuratObject
#> Loading required package: sp
#> 'SeuratObject' was built with package 'Matrix' 1.6.3 but the current
#> version is 1.6.4; it is recomended that you reinstall 'SeuratObject' as
#> the ABI for 'Matrix' may have changed
#> 
#> Attaching package: 'SeuratObject'
#> The following objects are masked from 'package:base':
#> 
#>     %||%, intersect
#> 
#> Attaching package: 'Seurat'
#> The following object is masked from 'package:base':
#> 
#>     %||%
library(curl)
#> Using libcurl 7.81.0 with OpenSSL/3.0.2
library(SimBu)

This chapter covers the different input and output options of the package in detail.

Input

The input for your simulations is always a SummarizedExperiment object. You can create this object with different constructing functions, which will explained below. It is also possible to merge multiple datasets objects into one.
Sfaira is not covered in this vignette, but in “Public Data Integration”.\

Custom data

Using existing count matrices and annotations is already covered in the “Getting started” vignette; this section will explain some minor details.\

When generating a dataset with your own data, you need to provide the count_matrix parameter of dataset(); additionally you can provide a TPM matrix with the tpm_matrix. This will then lead to two simulations, one based on counts and one based on TPMs. For either of them, genes are located in the rows, cells in the columns.
Additionally, an annotation table is needed, with the cell-type annotations. It needs to consist of at least out of 2 columns: ID and cell_type, where ID has to be identical to the column names of the provides matrix/matrices. If not all cells appear in the annotation or matrix, the intersection of both is used to generate the dataset. \

Here is some example data:

counts <- Matrix::Matrix(matrix(stats::rpois(3e5, 5), ncol = 300), sparse = TRUE)
tpm <- Matrix::Matrix(matrix(stats::rpois(3e5, 5), ncol = 300), sparse = TRUE)
tpm <- Matrix::t(1e6 * Matrix::t(tpm) / Matrix::colSums(tpm))
colnames(counts) <- paste0("cell-", rep(1:300))
colnames(tpm) <- paste0("cell-", rep(1:300))
rownames(counts) <- paste0("gene-", rep(1:1000))
rownames(tpm) <- paste0("gene-", rep(1:1000))
annotation <- data.frame(
  "ID" = paste0("cell-", rep(1:300)),
  "cell_type" = c(
    rep("T cells CD4", 50),
    rep("T cells CD8", 50),
    rep("Macrophages", 100),
    rep("NK cells", 10),
    rep("B cells", 70),
    rep("Monocytes", 20)
  ),
  row.names = paste0("cell-", rep(1:300))
)
seurat_obj <- Seurat::CreateSeuratObject(counts = counts, assay = "gene_expression", meta.data = annotation)
# store normalized matrix in the 'data' layer
SeuratObject::LayerData(seurat_obj, assay = "gene_expression", layer = "data") <- tpm
seurat_obj
#> An object of class Seurat 
#> 1000 features across 300 samples within 1 assay 
#> Active assay: gene_expression (1000 features, 0 variable features)
#>  2 layers present: counts, data

Seurat

It is possible to use a Seurat object to build a dataset; give the name of the assay containing count data in the counts slot, the name of the column in the meta table with the unique cell IDs and the name of the column in the meta table with the cell type identifier. Additionally you may give the name of the assay containing TPM data in the counts slot.

ds_seurat <- SimBu::dataset_seurat(
  seurat_obj = seurat_obj,
  counts_layer = "counts",
  cell_id_col = "ID",
  cell_type_col = "cell_type",
  tpm_layer = "data",
  name = "seurat_dataset"
)
#> Filtering genes...
#> Created dataset.

h5ad files

It is possible to use an h5ad file directly, a file format which stores AnnData objects. As h5ad files can store cell specific information in the obs layer, no additional annotation input for SimBu is needed.
Note: if you want both counts and tpm data as input, you will have to provide two files; the cell annotation has to match between these two files. As SimBu expects the cells to be in the columns and genes/features in the rows of the input matrix, but this is not necessarily the case for anndata objects https://falexwolf.de/img/scanpy/anndata.svg, SimBu can handle h5ad files with cells in the obs or var layer. If your cells are in obs, use cells_in_obs=TRUE and FALSE otherwise. This will also automatically transpose the matrix. To know, which columns in the cell annotation layer correspond to the cell identifiers and cell type labels, use the cell_id_col and cell_type_col parameters, respectively.\

As this function uses the SimBu python environment to read the h5ad files and extract the data, it may take some more time to initialize the conda environment at the first usage only.

# example h5ad file, where cell type info is stored in `obs` layer
# h5 <- system.file("extdata", "anndata.h5ad", package = "SimBu")
# ds_h5ad <- SimBu::dataset_h5ad(
#  h5ad_file_counts = h5,
#  name = "h5ad_dataset",
#  cell_id_col = 0, # this will use the rownames of the metadata as cell identifiers
#  cell_type_col = "group", # this will use the 'group' column of the metadata as cell type info
#  cells_in_obs = TRUE # in case your cell information is stored in the var layer, switch to FALSE
# )

Merging datasets

You are able to merge multiple datasets by using the dataset_merge function:

ds <- SimBu::dataset(
  annotation = annotation,
  count_matrix = counts,
  tpm_matrix = tpm,
  name = "test_dataset"
)
#> Filtering genes...
#> Created dataset.
ds_multiple <- SimBu::dataset_merge(
  dataset_list = list(ds_seurat, ds),
  name = "ds_multiple"
)
#> Filtering genes...
#> Created dataset.

Output

The simulation object contains three named entries: \

simulation <- SimBu::simulate_bulk(
  data = ds_multiple,
  scenario = "random",
  scaling_factor = "NONE",
  nsamples = 10, ncells = 100
)
#> Finished simulation.
dim(SummarizedExperiment::assays(simulation$bulk)[["bulk_counts"]])
#> [1] 1000   10
dim(SummarizedExperiment::assays(simulation$bulk)[["bulk_tpm"]])
#> [1] 1000   10

If only the count matrix was given to the dataset initially, only the bulk_counts assay is filled.

utils::sessionInfo()
#> R Under development (unstable) (2023-11-11 r85510)
#> Platform: x86_64-pc-linux-gnu
#> Running under: Ubuntu 22.04.3 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_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] curl_5.2.0         Seurat_5.0.1       SeuratObject_5.0.1 sp_2.1-2          
#> [5] SimBu_1.5.4       
#> 
#> loaded via a namespace (and not attached):
#>   [1] RColorBrewer_1.1-3          jsonlite_1.8.8             
#>   [3] magrittr_2.0.3              spatstat.utils_3.0-4       
#>   [5] farver_2.1.1                rmarkdown_2.25             
#>   [7] zlibbioc_1.49.0             vctrs_0.6.5                
#>   [9] ROCR_1.0-11                 spatstat.explore_3.2-5     
#>  [11] RCurl_1.98-1.13             htmltools_0.5.7            
#>  [13] S4Arrays_1.3.1              SparseArray_1.3.1          
#>  [15] sass_0.4.8                  sctransform_0.4.1          
#>  [17] parallelly_1.36.0           KernSmooth_2.23-22         
#>  [19] bslib_0.6.1                 htmlwidgets_1.6.4          
#>  [21] ica_1.0-3                   plyr_1.8.9                 
#>  [23] plotly_4.10.3               zoo_1.8-12                 
#>  [25] cachem_1.0.8                igraph_1.6.0               
#>  [27] mime_0.12                   lifecycle_1.0.4            
#>  [29] pkgconfig_2.0.3             Matrix_1.6-4               
#>  [31] R6_2.5.1                    fastmap_1.1.1              
#>  [33] GenomeInfoDbData_1.2.11     MatrixGenerics_1.15.0      
#>  [35] fitdistrplus_1.1-11         future_1.33.0              
#>  [37] shiny_1.8.0                 digest_0.6.33              
#>  [39] colorspace_2.1-0            patchwork_1.1.3            
#>  [41] S4Vectors_0.41.2            tensor_1.5                 
#>  [43] RSpectra_0.16-1             irlba_2.3.5.1              
#>  [45] GenomicRanges_1.55.1        labeling_0.4.3             
#>  [47] progressr_0.14.0            spatstat.sparse_3.0-3      
#>  [49] fansi_1.0.6                 polyclip_1.10-6            
#>  [51] httr_1.4.7                  abind_1.4-5                
#>  [53] compiler_4.4.0              withr_2.5.2                
#>  [55] BiocParallel_1.37.0         fastDummies_1.7.3          
#>  [57] highr_0.10                  MASS_7.3-60.1              
#>  [59] proxyC_0.3.4                DelayedArray_0.29.0        
#>  [61] tools_4.4.0                 lmtest_0.9-40              
#>  [63] httpuv_1.6.13               future.apply_1.11.0        
#>  [65] goftest_1.2-3               glue_1.6.2                 
#>  [67] nlme_3.1-164                promises_1.2.1             
#>  [69] grid_4.4.0                  Rtsne_0.17                 
#>  [71] cluster_2.1.6               reshape2_1.4.4             
#>  [73] generics_0.1.3              spatstat.data_3.0-3        
#>  [75] gtable_0.3.4                tidyr_1.3.0                
#>  [77] data.table_1.14.10          utf8_1.2.4                 
#>  [79] XVector_0.43.0              spatstat.geom_3.2-7        
#>  [81] BiocGenerics_0.49.1         RcppAnnoy_0.0.21           
#>  [83] stringr_1.5.1               ggrepel_0.9.4              
#>  [85] RANN_2.6.1                  pillar_1.9.0               
#>  [87] spam_2.10-0                 RcppHNSW_0.5.0             
#>  [89] later_1.3.2                 splines_4.4.0              
#>  [91] dplyr_1.1.4                 lattice_0.22-5             
#>  [93] deldir_2.0-2                survival_3.5-7             
#>  [95] tidyselect_1.2.0            miniUI_0.1.1.1             
#>  [97] pbapply_1.7-2               knitr_1.45                 
#>  [99] gridExtra_2.3               IRanges_2.37.0             
#> [101] SummarizedExperiment_1.33.1 scattermore_1.2            
#> [103] stats4_4.4.0                xfun_0.41                  
#> [105] Biobase_2.63.0              matrixStats_1.2.0          
#> [107] stringi_1.8.3               lazyeval_0.2.2             
#> [109] yaml_2.3.8                  evaluate_0.23              
#> [111] codetools_0.2-19            tibble_3.2.1               
#> [113] cli_3.6.2                   uwot_0.1.16                
#> [115] RcppParallel_5.1.7          xtable_1.8-4               
#> [117] reticulate_1.34.0           munsell_0.5.0              
#> [119] jquerylib_0.1.4             Rcpp_1.0.11                
#> [121] GenomeInfoDb_1.39.3         spatstat.random_3.2-2      
#> [123] globals_0.16.2              png_0.1-8                  
#> [125] parallel_4.4.0              ellipsis_0.3.2             
#> [127] ggplot2_3.4.4               dotCall64_1.1-1            
#> [129] sparseMatrixStats_1.15.0    bitops_1.0-7               
#> [131] listenv_0.9.0               viridisLite_0.4.2          
#> [133] scales_1.3.0                ggridges_0.5.5             
#> [135] leiden_0.4.3.1              purrr_1.0.2                
#> [137] crayon_1.5.2                rlang_1.1.2                
#> [139] cowplot_1.1.2