Note
This page was generated from
scvi_in_R.ipynb.
Interactive online version:
.
Some tutorial content may look better in light mode.
Integrating datasets with scVI in R#
In this tutorial, we go over how to use basic scvi-tools functionality in R. However, for more involved analyses, we suggest using scvi-tools from Python. Checkout the Scanpy_in_R tutorial for instructions on converting Seurat objects to anndata.
This tutorial requires Reticulate. Please check out our installation guide for instructions on installing Reticulate and scvi-tools.
Loading and processing data with Seurat#
We follow the basic Seurat tutorial for loading data and selecting highly variable genes.
Note: scvi-tools requires raw gene expression
[1]:
# install.packages("Seurat")
# install.packages("reticulate")
# install.packages("cowplot")
# install.packages("devtools")
# devtools::install_github("satijalab/seurat-data")
# SeuratData::InstallData("pbmc3k")
# install.packages("https://seurat.nygenome.org/src/contrib/ifnb.SeuratData_3.0.0.tar.gz", repos = NULL, type = "source")
# SeuratData::InstallData("ifnb")
# devtools::install_github("cellgeni/sceasy")
[2]:
# We will work within the Seurat framework
library(Seurat)
library(SeuratData)
data("pbmc3k")
pbmc <- pbmc3k
pbmc <- NormalizeData(pbmc, normalization.method = "LogNormalize", scale.factor = 10000)
pbmc[["percent.mt"]] <- PercentageFeatureSet(pbmc, pattern = "^MT-")
pbmc <- subset(pbmc, subset = nFeature_RNA > 200 & nFeature_RNA < 2500 & percent.mt < 5)
pbmc <- FindVariableFeatures(pbmc, selection.method = "vst", nfeatures = 2000)
top2000 <- head(VariableFeatures(pbmc), 2000)
pbmc <- pbmc[top2000]
print(pbmc) # Seurat object
Attaching SeuratObject
Registered S3 method overwritten by 'cli':
method from
print.boxx spatstat.geom
Warning message in if (is.na(desc)) {:
“the condition has length > 1 and only the first element will be used”
Warning message in if (is.na(desc)) {:
“the condition has length > 1 and only the first element will be used”
Warning message in if (is.na(desc)) {:
“the condition has length > 1 and only the first element will be used”
Warning message in if (is.na(desc)) {:
“the condition has length > 1 and only the first element will be used”
Warning message in if (is.na(desc)) {:
“the condition has length > 1 and only the first element will be used”
Warning message in if (is.na(desc)) {:
“the condition has length > 1 and only the first element will be used”
Warning message in if (is.na(desc)) {:
“the condition has length > 1 and only the first element will be used”
Warning message in if (is.na(desc)) {:
“the condition has length > 1 and only the first element will be used”
Warning message in if (is.na(desc)) {:
“the condition has length > 1 and only the first element will be used”
Warning message in if (is.na(desc)) {:
“the condition has length > 1 and only the first element will be used”
Warning message in if (is.na(desc)) {:
“the condition has length > 1 and only the first element will be used”
Warning message in if (is.na(desc)) {:
“the condition has length > 1 and only the first element will be used”
── Installed datasets ────────────────────────────────────────────────────────────────────────────────────────── SeuratData v0.2.1 ──
✔ ifnb 3.0.0 ✔ stxBrain 0.1.1
✔ pbmc3k 3.1.4
──────────────────────────────────────────────────────────────── Key ────────────────────────────────────────────────────────────────
✔ Dataset loaded successfully
❯ Dataset built with a newer version of Seurat than installed
❓ Unknown version of Seurat installed
An object of class Seurat
2000 features across 2638 samples within 1 assay
Active assay: RNA (2000 features, 2000 variable features)
Converting Seurat object to AnnData#
scvi-tools relies on the AnnData object. Here we show how to convert our Seurat object to anndata for scvi-tools.
[3]:
library(reticulate)
library(sceasy)
sc <- import("scanpy", convert = FALSE)
scvi <- import("scvi", convert = FALSE)
[4]:
adata <- convertFormat(pbmc, from="seurat", to="anndata", main_layer="counts", drop_single_values=FALSE)
print(adata) # Note generally in Python, dataset conventions are obs x var
AnnData object with n_obs × n_vars = 2638 × 2000
obs: 'orig.ident', 'nCount_RNA', 'nFeature_RNA', 'seurat_annotations', 'percent.mt'
var: 'vst.mean', 'vst.variance', 'vst.variance.expected', 'vst.variance.standardized', 'vst.variable'
Setup our AnnData for training#
Reticulate allows us to call Python code from R, giving the ability to use all of scvi-tools in R. We encourage you to checkout their documentation and specifically the section on type conversions in order to pass arguments to Python functions.
In this section, we show how to setup the AnnData for scvi-tools, create the model, train the model, and get the latent representation. For a more in depth description of setting up the data, you can checkout our introductory tutorial as well as our data loading tutorial.
[5]:
# run setup_anndata
scvi$model$SCVI$setup_anndata(adata)
# create the model
model = scvi$model$SCVI(adata)
# train the model
model$train()
# to specify the number of epochs when training:
# model$train(max_epochs = as.integer(400))
None
None
Getting the latent represenation and visualization#
Here we get the latent representation of the model and save it back in our Seurat object. Then we run UMAP and visualize.
[6]:
# get the latent represenation
latent = model$get_latent_representation()
# put it back in our original Seurat object
latent <- as.matrix(latent)
rownames(latent) = colnames(pbmc)
pbmc[["scvi"]] <- CreateDimReducObject(embeddings = latent, key = "scvi_", assay = DefaultAssay(pbmc))
Warning message:
“No columnames present in cell embeddings, setting to 'scvi_1:10'”
[7]:
# Find clusters, then run UMAP, and visualize
pbmc <- FindNeighbors(pbmc, dims = 1:10, reduction = "scvi")
pbmc <- FindClusters(pbmc, resolution =1)
pbmc <- RunUMAP(pbmc, dims = 1:10, reduction = "scvi", n.components = 2)
DimPlot(pbmc, reduction = "umap", pt.size = 3)
Computing nearest neighbor graph
Computing SNN
Modularity Optimizer version 1.3.0 by Ludo Waltman and Nees Jan van Eck
Number of nodes: 2638
Number of edges: 91574
Running Louvain algorithm...
Maximum modularity in 10 random starts: 0.7180
Number of communities: 9
Elapsed time: 0 seconds
Warning message:
“The default method for RunUMAP has changed from calling Python UMAP via reticulate to the R-native UWOT using the cosine metric
To use Python UMAP via reticulate, set umap.method to 'umap-learn' and metric to 'correlation'
This message will be shown once per session”
15:50:40 UMAP embedding parameters a = 0.9922 b = 1.112
15:50:40 Read 2638 rows and found 10 numeric columns
15:50:40 Using Annoy for neighbor search, n_neighbors = 30
15:50:40 Building Annoy index with metric = cosine, n_trees = 50
0% 10 20 30 40 50 60 70 80 90 100%
[----|----|----|----|----|----|----|----|----|----|
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
|
15:50:40 Writing NN index file to temp file /tmp/RtmpUpvcTO/file77e840ff25c4
15:50:40 Searching Annoy index using 1 thread, search_k = 3000
15:50:41 Annoy recall = 100%
15:50:42 Commencing smooth kNN distance calibration using 1 thread
15:50:42 Initializing from normalized Laplacian + noise
15:50:42 Commencing optimization for 500 epochs, with 92988 positive edges
15:50:53 Optimization finished

Finding differentially expressed genes with scVI latent space#
First, we put the seurat clusters into our original anndata.
[8]:
adata$obs$insert(adata$obs$shape[1], "seurat_clusters", pbmc[["seurat_clusters"]][,1])
None
Using our trained SCVI model, we call the differential_expression()
method We pass seurat_clusters
to the groupby argument and compare between cluster 1
and cluster 2
.
The output of DE is a DataFrame with the bayes factors. Bayes factors > 3 have high probability of being differentially expressed. You can also set fdr_target, which will return the differentially expressed genes based on the posteior expected FDR.
[9]:
DE <- model$differential_expression(adata, groupby="seurat_clusters", group1 = "1", group2 = "2")
[10]:
print(DE$head())
proba_de proba_not_de bayes_factor scale1 scale2 ... raw_normalized_mean2 is_de_fdr_0.05 comparison group1 group2
S100A9 1.0000 0.0000 18.420681 4.506278e-04 0.032313 ... 402.134918 True 1 vs 2 1 2
LTB 1.0000 0.0000 18.420681 1.823797e-02 0.000625 ... 4.501131 True 1 vs 2 1 2
TNNT1 0.9998 0.0002 8.516943 5.922994e-07 0.000195 ... 0.781376 True 1 vs 2 1 2
TYMP 0.9998 0.0002 8.516943 4.944333e-04 0.004283 ... 46.068295 True 1 vs 2 1 2
IL7R 0.9998 0.0002 8.516943 4.791361e-03 0.000243 ... 1.657865 True 1 vs 2 1 2
[5 rows x 22 columns]
Integrating datasets with scVI#
Here we integrate two datasets from Seurat’s Immune Alignment Vignette.
[11]:
data("ifnb")
# use seurat for variable gene selection
ifnb <- NormalizeData(ifnb, normalization.method = "LogNormalize", scale.factor = 10000)
ifnb[["percent.mt"]] <- PercentageFeatureSet(ifnb, pattern = "^MT-")
ifnb <- subset(ifnb, subset = nFeature_RNA > 200 & nFeature_RNA < 2500 & percent.mt < 5)
ifnb <- FindVariableFeatures(ifnb, selection.method = "vst", nfeatures = 2000)
top2000 <- head(VariableFeatures(ifnb), 2000)
ifnb <- ifnb[top2000]
[12]:
adata <- convertFormat(ifnb, from="seurat", to="anndata", main_layer="counts", drop_single_values=FALSE)
print(adata)
AnnData object with n_obs × n_vars = 13997 × 2000
obs: 'orig.ident', 'nCount_RNA', 'nFeature_RNA', 'stim', 'seurat_annotations', 'percent.mt'
var: 'vst.mean', 'vst.variance', 'vst.variance.expected', 'vst.variance.standardized', 'vst.variable'
[13]:
adata
AnnData object with n_obs × n_vars = 13997 × 2000
obs: 'orig.ident', 'nCount_RNA', 'nFeature_RNA', 'stim', 'seurat_annotations', 'percent.mt'
var: 'vst.mean', 'vst.variance', 'vst.variance.expected', 'vst.variance.standardized', 'vst.variable'
[14]:
# run setup_anndata, use column stim for batch
scvi$model$SCVI$setup_anndata(adata, batch_key = 'stim')
# create the model
model = scvi$model$SCVI(adata)
# train the model
model$train()
# to specify the number of epochs when training:
# model$train(max_epochs = as.integer(400))
None
None
[15]:
# get the latent represenation
latent = model$get_latent_representation()
# put it back in our original Seurat object
latent <- as.matrix(latent)
rownames(latent) = colnames(ifnb)
ifnb[["scvi"]] <- CreateDimReducObject(embeddings = latent, key = "scvi_", assay = DefaultAssay(ifnb))
Warning message:
“No columnames present in cell embeddings, setting to 'scvi_1:10'”
[16]:
library(cowplot)
# for jupyter notebook
options(repr.plot.width=10, repr.plot.height=8)
ifnb <- RunUMAP(ifnb, dims = 1:10, reduction = "scvi", n.components = 2)
p1 <- DimPlot(ifnb, reduction = "umap", group.by = "stim", pt.size=2)
plot_grid(p1)
16:17:21 UMAP embedding parameters a = 0.9922 b = 1.112
16:17:21 Read 13997 rows and found 10 numeric columns
16:17:21 Using Annoy for neighbor search, n_neighbors = 30
16:17:21 Building Annoy index with metric = cosine, n_trees = 50
0% 10 20 30 40 50 60 70 80 90 100%
[----|----|----|----|----|----|----|----|----|----|
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
*
|
16:17:25 Writing NN index file to temp file /tmp/RtmpUpvcTO/file77e83c6a593f
16:17:25 Searching Annoy index using 1 thread, search_k = 3000
16:17:34 Annoy recall = 100%
16:17:34 Commencing smooth kNN distance calibration using 1 thread
16:17:38 Initializing from normalized Laplacian + noise
16:17:38 Commencing optimization for 200 epochs, with 518726 positive edges
16:18:04 Optimization finished

[17]:
options(repr.plot.width=12, repr.plot.height=10)
FeaturePlot(ifnb, features = c("SELL", "CREM", "CD8A", "GNLY", "CD79A", "FCGR3A",
"CCL2", "PPBP"), min.cutoff = "q9")

[18]:
FeaturePlot(ifnb, features = c("GNLY", "IFI6"), split.by = "stim", max.cutoff = 3,
cols = c("grey", "red"))

Session Info Summary#
[19]:
sI <- sessionInfo()
sI$loadedOnly <- NULL
print(sI, locale=FALSE)
R version 4.0.3 (2020-10-10)
Platform: x86_64-conda-linux-gnu (64-bit)
Running under: Ubuntu 16.04.6 LTS
Matrix products: default
BLAS/LAPACK: /data/yosef2/users/jhong/miniconda3/envs/r_tutorial/lib/libopenblasp-r0.3.12.so
attached base packages:
[1] stats graphics grDevices utils datasets methods base
other attached packages:
[1] cowplot_1.1.1 sceasy_0.0.6
[3] reticulate_1.22 stxBrain.SeuratData_0.1.1
[5] pbmc3k.SeuratData_3.1.4 ifnb.SeuratData_3.0.0
[7] SeuratData_0.2.1 SeuratObject_4.0.2
[9] Seurat_4.0.4
[ ]: