Last updated: 2022-02-28

Checks: 7 0

Knit directory: STUtility_web_site/

This reproducible R Markdown analysis was created with workflowr (version 1.7.0). The Checks tab describes the reproducibility checks that were applied when the results were created. The Past versions tab lists the development history.


Great! Since the R Markdown file has been committed to the Git repository, you know the exact version of the code that produced these results.

Great job! The global environment was empty. Objects defined in the global environment can affect the analysis in your R Markdown file in unknown ways. For reproduciblity it’s best to always run the code in an empty environment.

The command set.seed(20191031) was run prior to running the code in the R Markdown file. Setting a seed ensures that any results that rely on randomness, e.g. subsampling or permutations, are reproducible.

Great job! Recording the operating system, R version, and package versions is critical for reproducibility.

Nice! There were no cached chunks for this analysis, so you can be confident that you successfully produced the results during this run.

Great job! Using relative paths to the files within your workflowr project makes it easier to run your code on other machines.

Great! You are using Git for version control. Tracking code development and connecting the code version to the results is critical for reproducibility.

The results in this page were generated with repository version 64ae8be. See the Past versions tab to see a history of the changes made to the R Markdown and HTML files.

Note that you need to be careful to ensure that all relevant files for the analysis have been committed to Git prior to generating the results (you can use wflow_publish or wflow_git_commit). workflowr only checks the R Markdown file, but you know if there are other scripts or data files that it depends on. Below is the status of the Git repository when the results were generated:


Ignored files:
    Ignored:    .Rhistory
    Ignored:    analysis/.DS_Store
    Ignored:    analysis/manual_annotation.png
    Ignored:    pre_data/

Note that any generated files, e.g. HTML, png, CSS, etc., are not included in this status report because it is ok for generated content to have uncommitted changes.


These are the previous versions of the repository in which changes were made to the R Markdown (analysis/Quality_Control.Rmd) and HTML (docs/Quality_Control.html) files. If you’ve configured a remote Git repository (see ?wflow_git_remote), click on the hyperlinks in the table below to view the files as they were in that past version.

File Version Author Date Message
html d41bcb0 Ludvig Larsson 2022-02-28 Build site.
html 0dafcee Ludvig Larsson 2021-05-06 Build site.
html df62517 Ludvig Larsson 2021-05-06 Build site.
html 88b046f Ludvig Larsson 2021-05-05 Build site.
html f34bd02 Ludvig Larsson 2021-05-05 wflow_git_commit(all = TRUE)
Rmd f8f90b4 Ludvig Larsson 2021-05-05 wflow_git_commit(all = TRUE)
html e0390c8 Ludvig Larsson 2021-05-05 Update
html 4af6496 Ludvig Larsson 2021-05-05 Updated tutorials
html 19353da Ludvig Larsson 2021-05-05 Updated tutorials
html b88bd19 Ludvig Larsson 2021-05-05 Build site.
html e526be2 Ludvig Larsson 2021-05-05 Build site.
html 3a8eb02 Ludvig Larsson 2021-05-04 Build site.
Rmd dfc9b23 Ludvig Larsson 2021-05-04 Added split data tutorial
html 395091f Ludvig Larsson 2021-05-04 Build site.
html da131a6 Ludvig Larsson 2021-05-04 Build site.
html 3ef1b70 Ludvig Larsson 2021-05-04 Build site.
Rmd fc3278a Ludvig Larsson 2021-05-04 Updated website with new theme and content
html 9fe84d9 Ludvig Larsson 2021-05-04 Build site.
html bfe87d1 Ludvig Larsson 2021-05-04 Build site.
Rmd eba61ce Ludvig Larsson 2021-05-04 Updated website with new theme and content
html 1dc000c Ludvig Larsson 2021-04-28 Build site.
html 1e9c615 Ludvig Larsson 2021-04-28 Build site.
html 34884bd Ludvig Larsson 2020-10-06 Build site.
html d13dabd Ludvig Larsson 2020-06-05 Build site.
html 60407bb Ludvig Larsson 2020-06-05 Build site.
html e339ebc Ludvig Larsson 2020-06-05 Build site.
html 6606127 Ludvig Larsson 2020-06-05 Build site.
html f0ea9c1 Ludvig Larsson 2020-06-05 Build site.
html 651f315 Ludvig Larsson 2020-06-05 Build site.
html a6a0c51 Ludvig Larsson 2020-06-05 Build site.
html f3c5cb4 Ludvig Larsson 2020-06-05 Build site.
html f89df7e Ludvig Larsson 2020-06-05 Build site.
html 1e67a7c Ludvig Larsson 2020-06-04 Build site.
html f71b0c0 Ludvig Larsson 2020-06-04 Build site.
Rmd 90a45cc Ludvig Larsson 2020-06-04 Fixed dataset in Load data
html 8a54a4d Ludvig Larsson 2020-06-04 Build site.
html 5e466eb Ludvig Larsson 2020-06-04 Build site.
Rmd 4819d2b Ludvig Larsson 2020-06-04 update website
html 377408d Ludvig Larsson 2020-06-04 Build site.
html ed54ffb Ludvig Larsson 2020-06-04 Build site.
html f14518c Ludvig Larsson 2020-06-04 Build site.
html efd885b Ludvig Larsson 2020-06-04 Build site.
html 4f42429 Ludvig Larsson 2020-06-04 Build site.
Rmd 3660612 Ludvig Larsson 2020-06-04 update website

library(STutility)
library(ggplot2)

Quality Control


Here we’ll go through some basic steps to assess the quality of your data and how to apply filters to remove low abundant genes and poor quality spots.

Include all spots

If you expect that you have over-permeabilized your tissue it could be useful to look at the expression patterns outside the tissue region as well. This can be done by loading the

Here we have a new infotable data.frame where the file paths in the “samples” column have been set to the “raw_feature_bc_matrix.h5” matrices instead of the filtered ones. Now we can load all spots into our Seurat object by setting disable.subset = TRUE.

infoTable
se <- InputFromTable(infoTable, disable.subset = TRUE)

The tissue borders are quite easy to see in the plot but you can also see that there have been transcripts captured also outside of the tissue. During library preparation, transcripts can diffuse out into the solution and end up anywhere outside the tissue but we can know from the TO experiments that the transcripts captured under the tissue form a cDNA footprint that accurately reflects the tissue morphology and that the transcripts have diffused vertically from the cells in the tissue down onto the capture area surface.

It can be good to keep this in mind when you see that you have holes in your tissue with no cells. You might detect quite a lot of transcripts in such holes and it is therefore important to carefully remove spots that are not covered by cells. If the automatic tissue detection algorithm run by spaceranger fails to find such holes, it could be a good idea to manually remove them using Loupe Browser before running spaceranger.

ST.FeaturePlot(se, features = "nFeature_RNA", cols = c("lightgray", "mistyrose", "red", "dark red", "black"), ncol = 2, pt.size = 1.3)

Version Author Date
bfe87d1 Ludvig Larsson 2021-05-04
1e9c615 Ludvig Larsson 2021-04-28
f71b0c0 Ludvig Larsson 2020-06-04
4f42429 Ludvig Larsson 2020-06-04

Now let’s load the data with the subsetting enabled. Here we can use wither the raw matrices or the filtered matrices as long as we have spotfiles available in our infoTable data.frame which will be used to select the spots under tissue.

se <- InputFromTable(infoTable)

Sometimes it can be a good idea to filter the data to remove low quality spots or low abundant genes. When running InputFromTable, spots with 0 counts will automatically be removed but you also have the option to filter the data directly using one of the following arguments:

  • min.gene.count : sets a threshold for the minimum allowed UMI counts of a gene across the whole dataset
  • min.gene.spots : sets a threshold for the minimum allowed number of spots where a gene is detected cross the whole dataset
  • min.spot.feature.count : sets a threshold for the minimum allowed number of unique genes in a spot
  • min.spot.count : sets a threshold for the minimum allowed UMI counts in a spot
  • topN : subset the expression matrix to include only the topN most expressed genes

You can also apply filters when the Seurat obect has been created which gives you more freedom to explore what could be a good threshold. Below we have plotted some basic features that you can use to define your filtering thresholds when running InputFromTable.

p1 <- ggplot() +
  geom_histogram(data = se[[]], aes(nFeature_RNA), fill = "red", alpha = 0.7, bins = 50) +
  ggtitle("Unique genes per spot")

p2 <- ggplot() +
  geom_histogram(data = se[[]], aes(nCount_RNA), fill = "red", alpha = 0.7, bins = 50) +
  ggtitle("Total counts per spots")

gene_attr <- data.frame(nUMI = Matrix::rowSums(se@assays$RNA@counts), 
                        nSpots = Matrix::rowSums(se@assays$RNA@counts > 0))
p3 <- ggplot() +
  geom_histogram(data = gene_attr, aes(nUMI), fill = "red", alpha = 0.7, bins = 50) +
  scale_x_log10() +
  ggtitle("Total counts per gene (log10 scale)")

p4 <- ggplot() +
  geom_histogram(data = gene_attr, aes(nSpots), fill = "red", alpha = 0.7,  bins = 50) +
  ggtitle("Total spots per gene")

(p1 - p2)/(p3 - p4)

Version Author Date
bfe87d1 Ludvig Larsson 2021-05-04
f71b0c0 Ludvig Larsson 2020-06-04
4f42429 Ludvig Larsson 2020-06-04

Filter out spots


Let’s say that we want to remove all spots with fewer than 500 unique genes we can simply subset the using the SubsetSTData function and an expression.

NOTE: The Seurat package provides a subset method for Seurat objects but unfotunately this method will not work when using STutility.

se.subset <- SubsetSTData(se, expression = nFeature_RNA > 500)

cat("Spots removed: ", ncol(se) - ncol(se.subset), "\n")
Spots removed:  42 

Mitochondrial content


It can also be useful to explore other features of the dataset to use for filtering, for example mitochondrial transcript content or ribosomal protein coding transcript content. Mitochondrial genes are prefixed with “mt-” in MGI nomenclature so we can collect these genes and then calculate the percentage of mitochondrial content per spot and add this information to our meta.data.

# Collect all genes coded on the mitochondrial genome
mt.genes <- grep(pattern = "^mt-", x = rownames(se), value = TRUE)
se$percent.mito <- (Matrix::colSums(se@assays$RNA@counts[mt.genes, ])/Matrix::colSums(se@assays$RNA@counts))*100

# Collect all genes coding for ribosomal proteins
rp.genes <- grep(pattern = "^Rpl|^Rps", x = rownames(se), value = TRUE)
se$percent.ribo <- (Matrix::colSums(se@assays$RNA@counts[rp.genes, ])/Matrix::colSums(se@assays$RNA@counts))*100

ST.FeaturePlot(se, features = "percent.mito", cols = c("lightgray", "mistyrose", "red", "dark red", "black"), pt.size = 1.3, ncol = 2)

Version Author Date
bfe87d1 Ludvig Larsson 2021-05-04
1e9c615 Ludvig Larsson 2021-04-28
f71b0c0 Ludvig Larsson 2020-06-04
4f42429 Ludvig Larsson 2020-06-04
ST.FeaturePlot(se, features = "percent.ribo", cols = c("lightgray", "mistyrose", "red", "dark red", "black"), pt.size = 1.3, ncol = 2)

Version Author Date
bfe87d1 Ludvig Larsson 2021-05-04
1e9c615 Ludvig Larsson 2021-04-28
f71b0c0 Ludvig Larsson 2020-06-04
4f42429 Ludvig Larsson 2020-06-04

We can also combine different thresholds to filter the data. Let’s say that we want to remove all spots with fewer than 500 unique genes and also spots with a high mitochondrial transcript content (>30%).

# Keep spots with more than 500 unique genes and less than 30% mitochondrial content
se.subset <- SubsetSTData(se, expression = nFeature_RNA > 500 & percent.mito < 30)

cat("Spots removed: ", ncol(se) - ncol(se.subset), "\n")
Spots removed:  180 

Removing genes


If you have good reson to remove a certain type of gene, this can also be done quite easily as well. For example, you might want to keep only protein coding genes in your dataset. Here we demonstrate how to subset a Seurat object to include only protein coding genes using our predefined covnersion table, but you could also get this information elsewhere, e.g. bioMart.

ensids <- read.table(file = list.files(system.file("extdata", package = "STutility"), full.names = T, pattern = "mouse_genes"), header = T, sep = "\t", stringsAsFactors = F)

# Print available biotypes
unique(ensids$gene_type)
keep.genes <- subset(ensids, gene_type %in% "protein_coding")$gene_name

# Subset Seurat object
se.subset <- se[intersect(rownames(se), keep.genes), ]

cat("Number of genes removed : ", nrow(se) - nrow(se.subset), "\n")
 

A work by Joseph Bergenstråhle and Ludvig Larsson

 


sessionInfo()
R version 4.0.3 (2020-10-10)
Platform: x86_64-apple-darwin13.4.0 (64-bit)
Running under: macOS Mojave 10.14.6

Matrix products: default
BLAS/LAPACK: /Users/ludviglarsson/anaconda3/envs/R4.0/lib/libopenblasp-r0.3.12.dylib

locale:
[1] en_US.UTF-8/en_US.UTF-8/en_US.UTF-8/C/en_US.UTF-8/en_US.UTF-8

attached base packages:
[1] stats     graphics  grDevices utils     datasets  methods   base     

other attached packages:
[1] magrittr_2.0.1     kableExtra_1.3.4   STutility_0.1.0    ggplot2_3.3.5     
[5] SeuratObject_4.0.0 Seurat_4.0.2       workflowr_1.7.0   

loaded via a namespace (and not attached):
  [1] utf8_1.2.1              reticulate_1.18         tidyselect_1.1.1       
  [4] htmlwidgets_1.5.3       grid_4.0.3              Rtsne_0.15             
  [7] munsell_0.5.0           codetools_0.2-18        ica_1.0-2              
 [10] units_0.7-1             future_1.21.0           miniUI_0.1.1.1         
 [13] withr_2.4.1             colorspace_2.0-0        highr_0.8              
 [16] knitr_1.31              uuid_0.1-4              rstudioapi_0.13        
 [19] ROCR_1.0-11             tensor_1.5              listenv_0.8.0          
 [22] labeling_0.4.2          git2r_0.28.0            polyclip_1.10-0        
 [25] farver_2.1.0            rprojroot_2.0.2         coda_0.19-4            
 [28] parallelly_1.25.0       LearnBayes_2.15.1       vctrs_0.3.8            
 [31] generics_0.1.0          xfun_0.20               R6_2.5.0               
 [34] doParallel_1.0.16       Morpho_2.8              ggiraph_0.7.8          
 [37] manipulateWidget_0.11.0 spatstat.utils_2.2-0    assertthat_0.2.1       
 [40] promises_1.2.0.1        scales_1.1.1            imager_0.42.8          
 [43] gtable_0.3.0            globals_0.14.0          bmp_0.3                
 [46] processx_3.5.1          goftest_1.2-2           rlang_1.0.1            
 [49] zeallot_0.1.0           akima_0.6-2.1           systemfonts_1.0.1      
 [52] splines_4.0.3           lazyeval_0.2.2          spatstat.geom_2.3-0    
 [55] rgl_0.105.22            yaml_2.2.1              reshape2_1.4.4         
 [58] abind_1.4-5             crosstalk_1.1.1         httpuv_1.5.5           
 [61] tools_4.0.3             spData_0.3.8            ellipsis_0.3.2         
 [64] spatstat.core_2.3-0     raster_3.4-10           jquerylib_0.1.3        
 [67] RColorBrewer_1.1-2      proxy_0.4-25            Rvcg_0.19.2            
 [70] ggridges_0.5.3          Rcpp_1.0.6              plyr_1.8.6             
 [73] classInt_0.4-3          purrr_0.3.4             ps_1.6.0               
 [76] rpart_4.1-15            dbscan_1.1-6            deldir_1.0-6           
 [79] pbapply_1.4-3           viridis_0.6.1           cowplot_1.1.1          
 [82] zoo_1.8-9               ggrepel_0.9.1           cluster_2.1.1          
 [85] colorRamps_2.3          fs_1.5.0                data.table_1.14.0      
 [88] magick_2.7.2            scattermore_0.7         readbitmap_0.1.5       
 [91] gmodels_2.18.1          lmtest_0.9-38           RANN_2.6.1             
 [94] whisker_0.4             fitdistrplus_1.1-3      matrixStats_0.58.0     
 [97] patchwork_1.1.1         shinyjs_2.0.0           mime_0.10              
[100] evaluate_0.14           xtable_1.8-4            jpeg_0.1-8.1           
[103] gridExtra_2.3           compiler_4.0.3          tibble_3.1.6           
[106] KernSmooth_2.23-18      crayon_1.4.1            htmltools_0.5.1.1      
[109] mgcv_1.8-34             later_1.1.0.1           spdep_1.1-7            
[112] tiff_0.1-8              tidyr_1.2.0             expm_0.999-6           
[115] DBI_1.1.1               MASS_7.3-53.1           sf_0.9-8               
[118] boot_1.3-27             Matrix_1.3-2            cli_3.1.1              
[121] gdata_2.18.0            parallel_4.0.3          igraph_1.2.6           
[124] pkgconfig_2.0.3         getPass_0.2-2           sp_1.4-5               
[127] plotly_4.9.3            spatstat.sparse_2.0-0   xml2_1.3.2             
[130] foreach_1.5.1           svglite_2.0.0           bslib_0.2.4            
[133] webshot_0.5.2           rvest_1.0.0             stringr_1.4.0          
[136] callr_3.7.0             digest_0.6.27           sctransform_0.3.2      
[139] RcppAnnoy_0.0.18        spatstat.data_2.1-0     rmarkdown_2.7          
[142] leiden_0.3.7            uwot_0.1.10             gdtools_0.2.3          
[145] shiny_1.6.0             gtools_3.8.2            lifecycle_1.0.1        
[148] nlme_3.1-152            jsonlite_1.7.2          viridisLite_0.4.0      
[151] fansi_0.4.2             pillar_1.7.0            lattice_0.20-41        
[154] fastmap_1.1.0           httr_1.4.2              survival_3.2-10        
[157] glue_1.4.2              png_0.1-7               iterators_1.0.13       
[160] class_7.3-18            stringi_1.5.3           sass_0.3.1             
[163] dplyr_1.0.8             irlba_2.3.3             e1071_1.7-6            
[166] future.apply_1.7.0