PRECAST: simulation

Wei Liu

2024-03-19

This vignette introduces the PRECAST workflow for the analysis of integrating multiple spatial transcriptomics dataset. The workflow consists of three steps

We demonstrate the use of PRECAST to three simulated Visium data that are here, which can be downloaded to the current working path by the following command:

githubURL <- "https://github.com/feiyoung/PRECAST/blob/main/vignettes_data/data_simu.rda?raw=true"
download.file(githubURL,"data_simu.rda",mode='wb')

Then load to R

load("data_simu.rda")

The package can be loaded with the command:

library(PRECAST)
library(Seurat)

Load the simulated data

First, we view the the three simulated spatial transcriptomics data with Visium platform.

data_simu ## a list including three Seurat object with default assay: RNA

Check the content in data_simu.

head(data_simu[[1]])
row.names(data_simu[[1]])[1:10]

Create a PRECASTObject object

We show how to create a PRECASTObject object step by step. First, we create a Seurat list object using the count matrix and meta data of each data batch. Although data_simu is a prepared Seurat list object, we re-create a same objcet seuList to show the details.

## Get the gene-by-spot read count matrices
countList <- lapply(data_simu, function(x){
  assay <- DefaultAssay(x)
  GetAssayData(x, assay = assay, slot='counts')
  
} )

## Check the spatial coordinates: Yes, they are named as "row" and "col"!
head(data_simu[[1]]@meta.data)

## Get the meta data of each spot for each data batch
metadataList <- lapply(data_simu, function(x) x@meta.data)


## ensure the row.names of metadata in metaList are the same as that of colnames count matrix in countList
M <- length(countList)
for(r in 1:M){
  row.names(metadataList[[r]]) <- colnames(countList[[r]])
}


## Create the Seurat list  object

seuList <- list()
for(r in 1:M){
  seuList[[r]] <- CreateSeuratObject(counts = countList[[r]], meta.data=metadataList[[r]], project = "PRECASTsimu")
}

Prepare the PRECASTObject with preprocessing step.

Next, we use CreatePRECASTObject() to create a PRECASTObject based on the Seurat list object seuList. This function will do three things:

If the argument customGenelist is not NULL, then this function only does (3) based on customGenelist gene list.

In this simulated dataset, we don’t require to select genes, thus, we set customGenelist=row.names(seuList[[1]]), representing the user-defined gene list. User can retain the raw seurat list object by setting rawData.preserve = TRUE.

Fit PRECAST using simulated data

Add the model setting

Add adjacency matrix list and parameter setting of PRECAST. More model setting parameters can be found in model_set().

Fit PRECAST

For function PRECAST, users can specify the number of clusters \(K\) or set K to be an integer vector by using modified BIC(MBIC) to determine \(K\). For convenience, we give a single K here.

Other options Run for multiple K. Here, we set K=6:9.

  • Note: For parallel compuation based on Rcpp on Linux, users require to use the following system command to set the C_stack unlimited in case of R Error: C stack usage is too close to the limit.

ulimit -s unlimited

Besides, user can also use different initialization method by setting int.model, for example, set int.model=NULL; see the functions AddParSetting() and model_set() for more details.

Select a best model and re-organize the results by useing SelectModel(). Even though K is not a vector, it is also necessary to run SelectModel() to re-organize the results in PRECASTObj. The selected best K is 7 by using command str(PRECASTObj@resList).

Use ARI to check the performance of clustering:

We provide two methods to correct the batch effects in gene expression level. Method (1) is using only PRECAST results to obtain the batch corrected gene expressions if the species of data is unknown or the number of overlapped housekeeping genes between the variable genes in PRECASTObj@seulist and the genes in database is less than five. Method (2) is using bouth housekeeping gene and PRECAST results to obtain the batch corrected gene expressions.

Integrate the two samples by the function IntegrateSpaData. Because this is a simulated data, we use Method (1) by setting species='unknown'.

Visualization

First, user can choose a beautiful color schema using chooseColors().

cols_cluster <- chooseColors(palettes_name = 'Nature 10', n_colors = 7, plot_colors = TRUE)

Show the spatial scatter plot for clusters

p12 <- SpaPlot(seuInt, batch=NULL, cols=cols_cluster, point_size=2, combine=TRUE)
p12
# users can plot each sample by setting combine=FALSE

Users can re-plot the above figures for specific need by returning a ggplot list object. For example, we only plot the spatial heatmap of first two data batches.

pList <- SpaPlot(seuInt, batch=NULL, cols=cols_cluster, point_size=2, combine=FALSE, title_name=NULL)
drawFigs(pList[1:2], layout.dim = c(1,2), common.legend = TRUE, legend.position = 'right', align='hv')

Show the spatial UMAP/tNSE RGB plot

seuInt <- AddUMAP(seuInt) 
SpaPlot(seuInt, batch=NULL,item='RGB_UMAP',point_size=1, combine=TRUE, text_size=15)

## Plot tSNE RGB plot
#seuInt <- AddTSNE(seuInt) 
#SpaPlot(seuInt, batch=NULL,item='RGB_TSNE',point_size=2, combine=T, text_size=15)

Show the tSNE plot based on the extracted features from PRECAST to check the performance of integration.

seuInt <- AddTSNE(seuInt, n_comp = 2) 

p1 <- dimPlot(seuInt, item='cluster', font_family='serif', cols=cols_cluster) # Times New Roman
p2 <- dimPlot(seuInt, item='batch', point_size = 1,  font_family='serif')
drawFigs(list(p1, p2), common.legend=FALSE, align='hv') 
# It is noted that only sample batch 1 has cluster 4, and only sample batch 2 has cluster 7. 

Show the UMAP plot based on the extracted features from PRECAST.

dimPlot(seuInt, reduction = 'UMAP3', item='cluster', cols=cols_cluster, font_family='serif')

Users can also use the visualization functions in Seurat package:

library(Seurat)
p1 <- DimPlot(seuInt[,1: 4226], reduction = 'position', cols=cols_cluster, pt.size =1) # plot the first data batch: first 4226 spots.
p2 <- DimPlot(seuInt, reduction = 'tSNE',cols=cols_cluster, pt.size=1)
drawFigs(list(p1, p2), layout.dim = c(1,2), common.legend = TRUE)

Combined differential expression analysis

dat_deg <- FindAllMarkers(seuInt)
library(dplyr)
n <- 2
dat_deg %>%
  group_by(cluster) %>%
  top_n(n = n, wt = avg_log2FC) -> top10

head(top10)

Session Info

sessionInfo()
#> R version 4.2.1 (2022-06-23 ucrt)
#> Platform: x86_64-w64-mingw32/x64 (64-bit)
#> Running under: Windows 10 x64 (build 22621)
#> 
#> Matrix products: default
#> 
#> locale:
#> [1] LC_COLLATE=C                               
#> [2] LC_CTYPE=Chinese (Simplified)_China.utf8   
#> [3] LC_MONETARY=Chinese (Simplified)_China.utf8
#> [4] LC_NUMERIC=C                               
#> [5] LC_TIME=Chinese (Simplified)_China.utf8    
#> 
#> attached base packages:
#> [1] parallel  stats     graphics  grDevices utils     datasets  methods  
#> [8] base     
#> 
#> other attached packages:
#> [1] PRECAST_1.6.5 gtools_3.9.4 
#> 
#> loaded via a namespace (and not attached):
#>   [1] utf8_1.2.3                  spatstat.explore_3.2-1     
#>   [3] reticulate_1.30             tidyselect_1.2.0           
#>   [5] htmlwidgets_1.6.2           grid_4.2.1                 
#>   [7] BiocParallel_1.32.6         Rtsne_0.16                 
#>   [9] munsell_0.5.0               ScaledMatrix_1.6.0         
#>  [11] codetools_0.2-19            ica_1.0-3                  
#>  [13] future_1.33.0               miniUI_0.1.1.1             
#>  [15] spatstat.random_3.1-5       colorspace_2.1-0           
#>  [17] progressr_0.13.0            Biobase_2.58.0             
#>  [19] knitr_1.43                  rstudioapi_0.14            
#>  [21] Seurat_5.0.2                stats4_4.2.1               
#>  [23] SingleCellExperiment_1.20.1 ROCR_1.0-11                
#>  [25] ggsignif_0.6.4              tensor_1.5                 
#>  [27] listenv_0.9.0               MatrixGenerics_1.10.0      
#>  [29] GenomeInfoDbData_1.2.9      polyclip_1.10-4            
#>  [31] parallelly_1.36.0           vctrs_0.6.3                
#>  [33] generics_0.1.3              xfun_0.39                  
#>  [35] ggthemes_4.2.4              R6_2.5.1                   
#>  [37] GenomeInfoDb_1.34.9         ggbeeswarm_0.7.2           
#>  [39] rsvd_1.0.5                  bitops_1.0-7               
#>  [41] spatstat.utils_3.0-3        cachem_1.0.8               
#>  [43] DelayedArray_0.24.0         promises_1.2.0.1           
#>  [45] scales_1.2.1                beeswarm_0.4.0             
#>  [47] gtable_0.3.3                beachmat_2.14.2            
#>  [49] globals_0.16.2              goftest_1.2-3              
#>  [51] spam_2.9-1                  rlang_1.1.1                
#>  [53] splines_4.2.1               rstatix_0.7.2              
#>  [55] lazyeval_0.2.2              broom_1.0.5                
#>  [57] spatstat.geom_3.2-4         yaml_2.3.7                 
#>  [59] reshape2_1.4.4              abind_1.4-5                
#>  [61] backports_1.4.1             httpuv_1.6.11              
#>  [63] tools_4.2.1                 ggplot2_3.4.2              
#>  [65] ellipsis_0.3.2              jquerylib_0.1.4            
#>  [67] RColorBrewer_1.1-3          BiocGenerics_0.44.0        
#>  [69] ggridges_0.5.4              Rcpp_1.0.11                
#>  [71] plyr_1.8.8                  sparseMatrixStats_1.10.0   
#>  [73] zlibbioc_1.44.0             purrr_1.0.1                
#>  [75] RCurl_1.98-1.12             ggpubr_0.6.0               
#>  [77] deldir_1.0-9                pbapply_1.7-2              
#>  [79] viridis_0.6.3               cowplot_1.1.1              
#>  [81] S4Vectors_0.36.2            zoo_1.8-12                 
#>  [83] SeuratObject_5.0.1          SummarizedExperiment_1.28.0
#>  [85] ggrepel_0.9.3               cluster_2.1.4              
#>  [87] magrittr_2.0.3              GiRaF_1.0.1                
#>  [89] data.table_1.14.8           RSpectra_0.16-1            
#>  [91] scattermore_1.2             lmtest_0.9-40              
#>  [93] RANN_2.6.1                  fitdistrplus_1.1-11        
#>  [95] matrixStats_1.0.0           patchwork_1.1.2            
#>  [97] mime_0.12                   evaluate_0.21              
#>  [99] xtable_1.8-4                mclust_6.0.0               
#> [101] fastDummies_1.7.3           IRanges_2.32.0             
#> [103] gridExtra_2.3               compiler_4.2.1             
#> [105] scater_1.27.4               tibble_3.2.1               
#> [107] KernSmooth_2.23-21          htmltools_0.5.5            
#> [109] later_1.3.1                 tidyr_1.3.0                
#> [111] formatR_1.14                MASS_7.3-60                
#> [113] car_3.1-2                   Matrix_1.6-5               
#> [115] cli_3.4.1                   dotCall64_1.0-2            
#> [117] igraph_1.5.0.1              DR.SC_3.3                  
#> [119] GenomicRanges_1.50.2        pkgconfig_2.0.3            
#> [121] sp_2.0-0                    plotly_4.10.2              
#> [123] scuttle_1.8.4               spatstat.sparse_3.0-2      
#> [125] vipor_0.4.5                 bslib_0.5.0                
#> [127] XVector_0.38.0              CompQuadForm_1.4.3         
#> [129] stringr_1.5.0               digest_0.6.33              
#> [131] sctransform_0.4.1           RcppAnnoy_0.0.21           
#> [133] spatstat.data_3.0-1         rmarkdown_2.23             
#> [135] leiden_0.4.3                uwot_0.1.16                
#> [137] DelayedMatrixStats_1.20.0   shiny_1.7.4.1              
#> [139] lifecycle_1.0.3             nlme_3.1-162               
#> [141] jsonlite_1.8.7              carData_3.0-5              
#> [143] BiocNeighbors_1.16.0        viridisLite_0.4.2          
#> [145] fansi_1.0.4                 pillar_1.9.0               
#> [147] lattice_0.21-8              fastmap_1.1.1              
#> [149] httr_1.4.6                  survival_3.5-5             
#> [151] glue_1.6.2                  png_0.1-8                  
#> [153] stringi_1.7.12              sass_0.4.7                 
#> [155] RcppHNSW_0.4.1              BiocSingular_1.14.0        
#> [157] dplyr_1.1.2                 irlba_2.3.5.1              
#> [159] future.apply_1.11.0