This vignette endeavors to put Bioconductor and scvi-tools together to help understand how different data structures and methods relevant to CITE-seq analysis contribute to interpretation of CITE-seq exeperiments.
The scvi-tools tutorial (for version 0.20.0) analyzes a pair of 10x PBMC CITE-seq experiments (5k and 10k cells). Chapter 12 of the OSCA book analyzes only the 10k dataset.
The following subsections are essentially “code-only”. We exhibit steps necessary to assemble a SingleCellExperiment instance with the subset of the totalVI quantifications produced for the cells from the “10k” dataset.
## class: SingleCellExperiment 
## dim: 33538 7472 
## metadata(2): Samples se.averaged
## assays(2): counts logcounts
## rownames(33538): ENSG00000243485 ENSG00000237613 ... ENSG00000277475
##   ENSG00000268674
## rowData names(3): ID Symbol Type
## colnames(7472): AAACCCAAGATTGTGA-1 AAACCCACATCGGTTA-1 ...
##   TTTGTTGTCGAGTGAG-1 TTTGTTGTCGTTCAGA-1
## colData names(3): Sample Barcode sizeFactor
## reducedDimNames(0):
## mainExpName: Gene Expression
## altExpNames(1): Antibody Capture## AnnData object with n_obs × n_vars = 10849 × 4000
##     obs: 'n_genes', 'percent_mito', 'n_counts', 'batch', '_scvi_labels', '_scvi_batch', 'leiden_totalVI'
##     var: 'highly_variable', 'highly_variable_rank', 'means', 'variances', 'variances_norm', 'highly_variable_nbatches'
##     uns: '_scvi_manager_uuid', '_scvi_uuid', 'hvg', 'leiden', 'log1p', 'neighbors', 'umap'
##     obsm: 'X_totalVI', 'X_umap', 'denoised_protein', 'protein_expression', 'protein_foreground_prob'
##     layers: 'counts', 'denoised_rna'
##     obsp: 'connectivities', 'distances'In this section we reduce the cell collections to cells common to the chapter 12 and totalVI datasets.
# select and order
totvi_latent = totvi_latent[comm,]
totvi_umap = totvi_umap[comm,]
totvi_denoised_rna = totvi_denoised_rna[comm,]
totvi_denoised_protein = totvi_denoised_protein[comm,]
totvi_leiden = totvi_leiden[comm]
 
# organize the totalVI into SCE with altExp
totsce = SingleCellExperiment(SimpleList(logcounts=t(totvi_denoised_rna))) # FALSE name
rowData(totsce) = S4Vectors::DataFrame(fullvi$var)
rownames(totsce) = rownames(fullvi$var)
rowData(totsce)$Symbol = rownames(totsce)
nn = SingleCellExperiment(SimpleList(logcounts=t(totvi_denoised_protein))) # FALSE name
reducedDims(nn) = list(UMAP=totvi_umap)
altExp(totsce) = nn
altExpNames(totsce) = "denoised_protein"
totsce$leiden = totvi_leiden
altExp(totsce)$leiden = totvi_leiden
altExp(totsce)$ch12.clusters = altExp(ch12sce[,comm])$label
# add average ADT abundance to metadata, for adt_profiles
tot.se.averaged <- sumCountsAcrossCells(altExp(totsce), altExp(totsce)$leiden,
    exprs_values="logcounts", average=TRUE)
rownames(tot.se.averaged) = gsub("_TotalSeqB", "", rownames(tot.se.averaged))
metadata(totsce)$se.averaged = tot.se.averagedThe TSNE projection of the normalized ADT quantifications and the walktrap cluster assignments are produced for the cells common to the two approaches.
## Warning: Removed 1 rows containing missing values (`geom_text_repel()`).This heatmap uses precomputed cluster averages that are lodged in the metadata element of the SingleCellExperiment. Colors represent the log2-fold change from the grand average across all clusters.
We enhance the annotation of the list of subclusters retrieved
using getCh12AllSce and then drill into mRNA-based
subclusters of ADT-based cluster 3 to compare expression levels
of three genes.
ch12_allsce = getCh12AllSce() 
ch12_allsce = lapply(ch12_allsce, function(x) {
   colnames(x)= x$Barcode; 
   cn = colnames(x); 
   x = x[,intersect(cn,comm)]; x})
of.interest <- "3"
markers <- c("GZMH", "IL7R", "KLRB1")
plotExpression(ch12_allsce[[of.interest]], x="subcluster",
    features=markers, swap_rownames="Symbol", ncol=3)There is a suggestion of a boolean basis for subcluster identity, depending on low or high expression of the selected genes.
Following the exploration in OSCA chapter 12, cluster 3 is analyzed for a regression association between expression measures of three genes and the ADT-based abundance of CD127.
plotExpression(ch12_allsce[["3"]], x="CD127", show_smooth=TRUE, show_se=FALSE, 
    features=c("IL7R", "TPT1", "KLRB1", "GZMH"), swap_rownames="Symbol")## `geom_smooth()` using method = 'loess' and formula = 'y ~ x'The approach to profiling the ADT abundances used in the totalVI tutorial employs scaling to (0,1).
tav = S4Vectors::metadata(totsce)$se.averaged
ata = assay(tav)
uscale = function(x) (x-min(x))/max(x)
scmat = t(apply(ata,1,uscale))
pheatmap::pheatmap(scmat, cluster_rows=FALSE)A quick view of the concordance of the two clustering outcomes is
atot = altExp(totsce)
ach12 = altExp(ch12sce_matched)
tt = table(ch12=ach12$label, VI=atot$leiden)
pheatmap::pheatmap(log(tt+1))With this we can pick out some clusters with many cells in common:
lit = tt[c("9", "12", "5", "3"), c("0", "1", "2", "8", "6", "5")]
rownames(lit) = sQuote(rownames(lit))
colnames(lit) = sQuote(colnames(lit))
lit##       VI
## ch12    '0'  '1'  '2'  '8'  '6'  '5'
##   '9'  1334    0    0    0    0    0
##   '12'    0  993    0    0   15    0
##   '5'     0  102  671    8   44    2
##   '3'     0    0    5  322  297   67Let’s examine the distributions of marker mRNAs in the Leiden totalVI clusters corresponding to OSCA cluster “3”:
tsub = totsce[,which(altExp(totsce)$leiden %in% c("5", "6", "8"))]
markers <- c("GZMH", "IL7R", "KLRB1")
altExp(tsub)$leiden = factor(altExp(tsub)$leiden) # squelch unused levels
tsub$leiden = factor(tsub$leiden) # squelch unused levels
plotExpression(tsub, x="leiden",
    features=markers, swap_rownames="Symbol", ncol=3)Note that the y axis label is incorrect – we are plotting the denoised expression values from totalVI.
The display seems roughly consistent with the “boolean basis” observed above with the mRNA-based subclustering.
The same approach is taken as above. We don’t have TPT1 in the 4000 genes retained in the totalVI exercise.
rn = rownames(altExp(tsub))
rn = gsub("_TotalSeqB", "", rn)
rownames(altExp(tsub)) = rn
rowData(altExp(tsub)) = DataFrame(Symbol=rn)
plotExpression(tsub, x="CD127", show_smooth=TRUE, show_se=FALSE,
   features=c("IL7R", "KLRB1", "GZMH"), swap_rownames="Symbol")## `geom_smooth()` using method = 'gam' and formula = 'y ~ s(x, bs = "cs")'We have shown how rudimentary programming and data organization can be used to make outputs of OSCA and totalVI methods amenable to comparison in the Bioconductor framework.
The scviR package includes a shiny app in the function
explore_subcl that should be expanded to facilitate
exploration of totalVI subclusters. Much more work
remains to be done in the area of exploring
additional approaches to integrative interpretation of ADT and mRNA abundance patterns, such as intersection and concatenation methods in the feature selection materials in OSCA ch. 12
effects of tuning and architecture details for the totalVI VAE
## R version 4.3.0 RC (2023-04-13 r84269)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 22.04.2 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.17-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] stats4    stats     graphics  grDevices utils     datasets  methods  
## [8] base     
## 
## other attached packages:
##  [1] scater_1.28.0               scuttle_1.10.0             
##  [3] reshape2_1.4.4              ggplot2_3.4.2              
##  [5] scviR_1.0.0                 SingleCellExperiment_1.22.0
##  [7] SummarizedExperiment_1.30.0 Biobase_2.60.0             
##  [9] GenomicRanges_1.52.0        GenomeInfoDb_1.36.0        
## [11] IRanges_2.34.0              S4Vectors_0.38.0           
## [13] BiocGenerics_0.46.0         MatrixGenerics_1.12.0      
## [15] matrixStats_0.63.0          shiny_1.7.4                
## [17] basilisk_1.12.0             BiocStyle_2.28.0           
## 
## loaded via a namespace (and not attached):
##   [1] DBI_1.1.3                 bitops_1.0-7             
##   [3] gridExtra_2.3             rlang_1.1.0              
##   [5] magrittr_2.0.3            compiler_4.3.0           
##   [7] RSQLite_2.3.1             mgcv_1.8-42              
##   [9] dir.expiry_1.8.0          DelayedMatrixStats_1.22.0
##  [11] png_0.1-8                 vctrs_0.6.2              
##  [13] stringr_1.5.0             pkgconfig_2.0.3          
##  [15] fastmap_1.1.1             magick_2.7.4             
##  [17] dbplyr_2.3.2              XVector_0.40.0           
##  [19] ellipsis_0.3.2            labeling_0.4.2           
##  [21] utf8_1.2.3                promises_1.2.0.1         
##  [23] rmarkdown_2.21            ggbeeswarm_0.7.1         
##  [25] purrr_1.0.1               bit_4.0.5                
##  [27] xfun_0.39                 zlibbioc_1.46.0          
##  [29] cachem_1.0.7              beachmat_2.16.0          
##  [31] jsonlite_1.8.4            blob_1.2.4               
##  [33] highr_0.10                later_1.3.0              
##  [35] DelayedArray_0.26.0       BiocParallel_1.34.0      
##  [37] irlba_2.3.5.1             parallel_4.3.0           
##  [39] R6_2.5.1                  stringi_1.7.12           
##  [41] bslib_0.4.2               RColorBrewer_1.1-3       
##  [43] limma_3.56.0              reticulate_1.28          
##  [45] jquerylib_0.1.4           Rcpp_1.0.10              
##  [47] bookdown_0.33             knitr_1.42               
##  [49] splines_4.3.0             httpuv_1.6.9             
##  [51] Matrix_1.5-4              tidyselect_1.2.0         
##  [53] yaml_2.3.7                viridis_0.6.2            
##  [55] codetools_0.2-19          curl_5.0.0               
##  [57] plyr_1.8.8                lattice_0.21-8           
##  [59] tibble_3.2.1              basilisk.utils_1.12.0    
##  [61] withr_2.5.0               evaluate_0.20            
##  [63] BiocFileCache_2.8.0       pillar_1.9.0             
##  [65] BiocManager_1.30.20       filelock_1.0.2           
##  [67] generics_0.1.3            rprojroot_2.0.3          
##  [69] RCurl_1.98-1.12           sparseMatrixStats_1.12.0 
##  [71] munsell_0.5.0             scales_1.2.1             
##  [73] xtable_1.8-4              glue_1.6.2               
##  [75] pheatmap_1.0.12           tools_4.3.0              
##  [77] BiocNeighbors_1.18.0      ScaledMatrix_1.8.0       
##  [79] cowplot_1.1.1             grid_4.3.0               
##  [81] colorspace_2.1-0          nlme_3.1-162             
##  [83] GenomeInfoDbData_1.2.10   beeswarm_0.4.0           
##  [85] BiocSingular_1.16.0       vipor_0.4.5              
##  [87] cli_3.6.1                 rsvd_1.0.5               
##  [89] fansi_1.0.4               viridisLite_0.4.1        
##  [91] dplyr_1.1.2               gtable_0.3.3             
##  [93] sass_0.4.5                digest_0.6.31            
##  [95] ggrepel_0.9.3             farver_2.1.1             
##  [97] memoise_2.0.1             htmltools_0.5.5          
##  [99] lifecycle_1.0.3           here_1.0.1               
## [101] httr_1.4.5                mime_0.12                
## [103] bit64_4.0.5