前言
在之前的一篇推文:SuperCell:基于metacell理念提高单细胞数据的可信度中,Immugent介绍了Supercell包的大致功能框架。从本期推文开始,生信宝库将会推出一系列的代码实操教程,手把手教大家如何将Supercell包运用到实际的单细胞数据分析流程中。
在本篇推文中,Immugent首先会使用Seurat运行一个标准的scRNA-seq数据分析流程(即数据归一化、特征选择、降维、可视化、聚类和差异表达式分析);然后,通过Supercell包计算元细胞,即是将转录高度相似的单细胞分组为元细胞)来简化相同的数据集;最后,Immugent对Supercell整合后的元细胞执行相同的标准下游分析,并将结果与在单细胞级别获得的结果进行比较。
下面就开始具体的代码展示。。。
主要内容
remotes::install_github("GfellerLab/SuperCell", force = TRUE, upgrade = FALSE)
library(SuperCell)
library(Seurat)
library(dplyr)
proj.name <- 'cell_lines'
.color.cell.type <- c("A549" = "#E69F00", "H838" = "#56B4E9", "H1975" = "#009E73", "H2228" = "#F0E442", "HCC827" = "#CC79A7")
data.folder <- file.path("..", "data", proj.name)
# load single-cell (sc) count matrix and cell metadata
sc.counts <- readRDS(file.path(data.folder, "sc_counts_filtered.Rds"))
sc.meta <- readRDS(file.path(data.folder, "sc_meta_filtered.Rds"))
# Make sure metadata and count matrix have the same cells in the same order
if(!identical(rownames(sc.meta), colnames(sc.counts))){
stop("Metadata (`sc.meta`) does not correspond to the count matrix (`sc.counts`)")
}
Standard downstream analysis
set.seed(12345)
sc <- CreateSeuratObject(counts = sc.counts, project = proj.name, meta.data = sc.meta)
sc
## An object of class Seurat
## 11786 features across 3822 samples within 1 assay
## Active assay: RNA (11786 features, 0 variable features)
sc <- NormalizeData(sc, verbose=FALSE)
sc <- FindVariableFeatures(
sc,
selection.method = "disp", # "vst" is default
nfeatures = 1000,
verbose=FALSE
)
hvg <- VariableFeatures(sc, verbose=FALSE)
# Plot variable features
plot1 <- VariableFeaturePlot(sc)
LabelPoints(plot = plot1, points = hvg[1:20], repel = TRUE)
sc <- ScaleData(sc, verbose=FALSE)
sc <- RunPCA(sc, verbose=FALSE)
# Plot PCA (2D representation of scRNA-seq data) colored by cell line
DimPlot(sc, reduction = "pca", group.by = "cell_line", cols = .color.cell.type)
data:image/s3,"s3://crabby-images/7c187/7c1878c6de44b530afc9d727a94134e3ce3d2d94" alt=""
sc <- RunUMAP(sc, dims = 1:10)
# Plot UMAP (2D representation of scRNA-seq data) colored by cell line
DimPlot(sc, reduction = "umap", group.by = "cell_line", cols = .color.cell.type)
sc <- FindNeighbors(sc, dims = 1:10)
sc <- FindClusters(sc, resolution = 0.05)
## Modularity Optimizer version 1.3.0 by Ludo Waltman and Nees Jan van Eck
##
## Number of nodes: 3822
## Number of edges: 121361
##
## Running Louvain algorithm...
## Maximum modularity in 10 random starts: 0.9890
## Number of communities: 5
## Elapsed time: 0 seconds
# As it is a toy example with well defined cell types (i.e., cell lines), unsupervised clustering fully recapitulates cell line annotation
table(sc@active.ident, sc$cell_line)
##
## A549 H1975 H2228 H838 HCC827
## 0 1237 0 0 0 0
## 1 0 0 0 841 0
## 2 0 0 744 0 0
## 3 0 0 0 0 571
## 4 0 429 0 0 0
DimPlot(sc, reduction = "umap", group.by = "ident")
data:image/s3,"s3://crabby-images/8fdca/8fdca6fc2c3b278601904c5d67933054b295b026" alt=""
data:image/s3,"s3://crabby-images/eb7c2/eb7c2bad2d2a1d5a839105c36677d711f77b8926" alt=""
Differential expression analysis
# Set idents to cell lines (as clusters are the same as cell lines)
Idents(sc) <- "cell_line"
levels(sc) <- sort(levels(sc))
# Compute upregulated genes in each cell line (versus other cells)
sc.all.markers <- FindAllMarkers(sc, only.pos = TRUE, min.pct = 0.25, logfc.threshold = 0.25, test.use = "t")
saveRDS(sc.all.markers, file = file.path(data.folder, "output", "sc_all_markers.Rds"))
# Load markers (backup)
#sc.all.markers <- readRDS(file = file.path(data.folder, "output", "sc_all_markers.Rds"))
# Top markers (select top markers of each cell line)
sc.top.markers <- sc.all.markers %>%
group_by(cluster) %>%
slice_max(n = 2, order_by = avg_log2FC)
sc.top.markers
## # A tibble: 10 × 7
## # Groups: cluster [5]
## p_val avg_log2FC pct.1 pct.2 p_val_adj cluster gene
## <dbl> <dbl> <dbl> <dbl> <dbl> <fct> <chr>
## 1 0 5.56 0.998 0.775 0 A549 KRT81
## 2 0 5.15 1 0.675 0 A549 AKR1B10
## 3 1.05e-180 3.26 0.991 0.323 1.24e-176 H1975 MT1E
## 4 1.42e-142 3.07 0.963 0.083 1.68e-138 H1975 DHRS2
## 5 0 4.08 0.997 0.371 0 H2228 SAA1
## 6 0 3.94 0.999 0.625 0 H2228 LCN2
## 7 0 4.20 1 0.245 0 H838 GAGE12D
## 8 0 4.01 1 0.176 0 H838 GAGE12E
## 9 0 4.17 1 0.996 0 HCC827 SEC61G
## 10 0 3.05 0.998 0.941 0 HCC827 CDK4
VlnPlot(sc, features = sc.top.markers$gene[c(seq(1, 9, 2), seq(2, 10, 2))], ncol = 5, pt.size = 0.0, cols = .color.cell.type)
data:image/s3,"s3://crabby-images/4734e/4734ead35cf717c46d491102137e8e4f9aee5fdb" alt=""
gamma <- 20 # Graining level
# Compute metacells using SuperCell package
MC <- SCimplify(
X = GetAssayData(sc), # single-cell log-normalized gene expression data
genes.use = hvg,
gamma = gamma,
n.pc = 10
)
# Compute gene expression of metacells by simply averaging gene expression within each metacell
MC.ge <- supercell_GE(
ge = GetAssayData(sc),
groups = MC$membership
)
# Alternatively, counts can be averaged (summed up) followed by a lognormalization step (this approach is used in the MetaCell and SEACell algorithms)
if(0){
MC.counts <- supercell_GE(
ge = GetAssayData(sc, slot = "counts"),
mode = "sum", # summing counts instead of the default averaging
groups = MC$membership
)
MC.ge <- Seurat::LogNormalize(MC.counts, verbose = FALSE)
}
# Annotate metacells to cells line
MC$cell_line <- supercell_assign(
cluster = sc.meta$cell_line, # single-cell assignment to cell lines
supercell_membership = MC$membership, # single-cell assignment to metacells
method = "absolute" # available methods are c("jaccard", "relative", "absolute"), function's help() for explanation
)
# Compute purity of metacells as :
# * a proportion of the most abundant cell type withing metacells (`method = `"max_proportion)
# * an entropy of cell type within metacells (`method = "entropy"`)
method_purity <- c("max_proportion", "entropy")[1]
MC$purity <- supercell_purity(
clusters = sc.meta$cell_line,
supercell_membership = MC$membership,
method = method_purity
)
# Metacell purity distribution
summary(MC$purity)
## Min. 1st Qu. Median Mean 3rd Qu. Max.
## 1 1 1 1 1 1
hist(MC$purity, main = paste0("Purity of metacells \nin terms of cell line composition (", method_purity,")"))
supercell_plot(
MC$graph.supercells,
group = MC$cell_line,
color.use = .color.cell.type,
seed = 1,
alpha = -pi/2,
main = "Metacells colored by cell line assignment")
supercell_plot(
MC$graph.singlecell,
group = sc.meta$cell_line,
color.use = .color.cell.type,
do.frames = FALSE,
lay.method = "components",
seed = 1,
alpha = -pi/2,
main = "Single cells colored by cell line assignment")
data:image/s3,"s3://crabby-images/c6b76/c6b76106e1d256d7f4d734830436b62bdca16bfa" alt=""
data:image/s3,"s3://crabby-images/27e0d/27e0dfe2cc73289e3483ed58adb8a857bf34a04c" alt=""
Standard downstream analysis of metacells
MC.seurat <- supercell_2_Seurat(
SC.GE = MC.ge,
SC = MC,
fields = c("cell_line", "purity"),
var.genes = MC$genes.use,
N.comp = 10
)
## [1] "Done: NormalizeData"
## [1] "Doing: data to normalized data"
## [1] "Doing: weighted scaling"
## [1] "Done: weighted scaling"
Idents(MC.seurat) <- "cell_line"
MC.seurat <- RunUMAP(MC.seurat, dims = 1:10)
## 19:46:08 UMAP embedding parameters a = 0.9922 b = 1.112
## 19:46:08 Read 191 rows and found 10 numeric columns
## 19:46:08 Using Annoy for neighbor search, n_neighbors = 30
## 19:46:08 Building Annoy index with metric = cosine, n_trees = 50
## 0% 10 20 30 40 50 60 70 80 90 100%
## [----|----|----|----|----|----|----|----|----|----|
## **************************************************|
## 19:46:08 Writing NN index file to temp file /var/folders/g3/m1nhnz5910s9mckg3ymbz_b80000gn/T//RtmpfJCuiA/file1e874ac9b766
## 19:46:08 Searching Annoy index using 1 thread, search_k = 3000
## 19:46:08 Annoy recall = 100%
## 19:46:08 Commencing smooth kNN distance calibration using 1 thread
## 19:46:09 Found 2 connected components, falling back to 'spca' initialization with init_sdev = 1
## 19:46:09 Initializing from PCA
## 19:46:09 Using 'irlba' for PCA
## 19:46:09 PCA: 2 components explained 49.92% variance
## 19:46:09 Commencing optimization for 500 epochs, with 6042 positive edges
## 19:46:09 Optimization finished
DimPlot(MC.seurat, cols = .color.cell.type, reduction = "umap")
MC.seurat <- FindClusters(MC.seurat, resolution = 0.5)
## Modularity Optimizer version 1.3.0 by Ludo Waltman and Nees Jan van Eck
##
## Number of nodes: 191
## Number of edges: 3703
##
## Running Louvain algorithm...
## Maximum modularity in 10 random starts: 0.8899
## Number of communities: 5
## Elapsed time: 0 seconds
DimPlot(MC.seurat, reduction = "umap")
data:image/s3,"s3://crabby-images/b40b5/b40b5df99366227d4e2550d18bc636bc601d7fb7" alt=""
data:image/s3,"s3://crabby-images/f5e99/f5e995f8dee2fa421329af862db882d3fed3016c" alt=""
# Set idents to cell lines (as clusters are the same as cell lines)
Idents(MC.seurat) <- "cell_line"
levels(MC.seurat) <- sort(levels(Idents(MC.seurat)))
# Compute upregulated genes in each cell line (versus other cells)
MC.seurat.all.markers <- FindAllMarkers(
MC.seurat,
only.pos = TRUE,
min.pct = 0.25,
logfc.threshold = 0.25,
test.use = "t"
)
saveRDS(MC.seurat.all.markers, file = file.path(data.folder, "output", paste0("MC_gamma_", gamma, "_all_markers_seurat.Rds")))
# Load markers (backup)
#MC.seurat.all.markers <- readRDS(file = file.path(data.folder, "output", "MC_gamma_20_all_markers_seurat.Rds"))
# Top markers (select top markers of each cell line)
MC.seurat.top.markers <- MC.seurat.all.markers %>%
group_by(cluster) %>%
slice_max(n = 2, order_by = avg_log2FC)
MC.seurat.top.markers
## # A tibble: 10 × 7
## # Groups: cluster [5]
## p_val avg_log2FC pct.1 pct.2 p_val_adj cluster gene
## <dbl> <dbl> <dbl> <dbl> <dbl> <fct> <chr>
## 1 2.08e-57 5.37 1 0.993 2.45e-53 A549 KRT81
## 2 1.03e-51 5.12 1 1 1.21e-47 A549 AKR1B10
## 3 1.89e-14 3.12 1 0.89 2.23e-10 H1975 MT1E
## 4 5.18e-12 2.84 1 0.695 6.11e- 8 H1975 DHRS2
## 5 9.90e-43 4.19 1 0.993 1.17e-38 H2228 LCN2
## 6 1.08e-32 4.09 1 0.954 1.28e-28 H2228 SAA1
## 7 2.11e-63 4.21 1 0.911 2.49e-59 H838 GAGE12D
## 8 1.24e-57 4.01 1 0.911 1.47e-53 H838 GAGE12E
## 9 2.48e-34 4.13 1 1 2.92e-30 HCC827 SEC61G
## 10 5.92e-30 3.02 1 1 6.98e-26 HCC827 CDK4
genes.to.plot <- MC.seurat.top.markers$gene[c(seq(1, 9, 2), seq(2, 10, 2))]
VlnPlot(MC.seurat, features = genes.to.plot, ncol = 5, pt.size = 0.0, cols = .color.cell.type)
data:image/s3,"s3://crabby-images/b827a/b827a61639eead75bc4e8dc179f1518d2d194a45" alt=""
gene_x <- MC$genes.use[500:505] #500
gene_y <- MC$genes.use[550:555] #600
alpha <- 0.7
p.SC <- supercell_GeneGenePlot(GetAssayData(sc, slot = "data"), gene_x = gene_x, gene_y = gene_y, clusters = sc$cell_line, color.use = .color.cell.type, sort.by.corr = F, alpha = alpha)
p.SC$p
p.MC <- supercell_GeneGenePlot(MC.ge, gene_x = gene_x, gene_y = gene_y, supercell_size = MC$supercell_size, clusters = MC$cell_line, color.use = .color.cell.type, sort.by.corr = F, alpha = alpha)
p.MC$p
data:image/s3,"s3://crabby-images/c5d6c/c5d6cc7cc3a72eedc4c412be5939e454f7b35510" alt=""
data:image/s3,"s3://crabby-images/786ef/786ef3aafccf5a375293099cb23142bc54caff84" alt=""
Alternative or Sample-weighted downstream analysis of metacells
MC$PCA <- supercell_prcomp(
Matrix::t(MC.ge),
genes.use = MC$genes.use, # or a new set of HVG can be computed
supercell_size = MC$supercell_size, # provide this parameter to run sample-weighted version of PCA,
k = 10
)
MC$UMAP <- supercell_UMAP(
SC = MC,
PCA_name = "PCA",
n_neighbors = 50 # large number to repel cells
)
supercell_DimPlot(
MC,
groups = MC$cell_line,
dim.name = "UMAP",
title = paste0("UMAP of metacells colored by cell line assignment"),
color.use = .color.cell.type
)
# compute distance among metacells
D <- dist(MC$PCA$x)
# cluster metacells
MC$clustering <- supercell_cluster(D = D, k = 5, supercell_size = MC$supercell_size)
# Plot clustering result
supercell_DimPlot(
MC,
groups = factor(MC$clustering$clustering),
dim.name = "UMAP",
title = paste0("UMAP of metacells colored by metacell clustering")
)
data:image/s3,"s3://crabby-images/8d81f/8d81f6a593b54208ecee4174087cfbe472e13690" alt=""
data:image/s3,"s3://crabby-images/37214/37214b582ba5776077f34e12a905419c5405c138" alt=""
# Compute upregulated genes in each cell line (versus other cells)
MC.all.markers <- supercell_FindAllMarkers(
ge = MC.ge,
clusters = MC$cell_line,
supercell_size = MC$supercell_size,
only.pos = TRUE,
min.pct = 0.25,
logfc.threshold = 0.25
)
saveRDS(MC.all.markers, file = file.path(data.folder, "output", paste0("MC_gamma_", gamma, "_all_markers.Rds")))
# Load markers (backup)
#MC.all.markers <- readRDS(file = file.path(data.folder, "output", "paste0("MC_gamma_", gamma, "_all_markers.Rds")))
# Transform the output of `supercell_FindAllMarkers()` to be in the format of the `Seurat::FindAllMarkers()`
MC.all.markers.df <- data.frame()
for(cl in names(MC.all.markers)){
cur <- MC.all.markers[[cl]]
cur$cluster <- cl
cur$gene <- rownames(cur)
cur$avg_log2FC <- cur$logFC
MC.all.markers.df <- rbind(MC.all.markers.df, cur)
}
# Top markers (select top markers of each cell line)
MC.top.markers <- MC.all.markers.df %>%
group_by(cluster) %>%
slice_max(n = 2, order_by = avg_log2FC)
supercell_VlnPlot(
ge = MC.ge,
supercell_size = MC$supercell_size,
clusters = MC$cell_line,
features = MC.top.markers$gene[c(seq(1, 9, 2), seq(2, 10, 2))],
color.use = .color.cell.type,
ncol = 5)
data:image/s3,"s3://crabby-images/2944f/2944f66fcebd1f07301232c469e72c87a78961d1" alt=""
展望
从上面的分析结果可以看出,相对于原始数据,经过Supercell整合后的元细胞具有更高的可信度。具体表现在:1.每个单元细胞的基因表达值更高;2.两两基因之间的相关性更强;3.整合后的细胞之间聚类也更紧密;此外,由于整合后的数据量大大减少,这也更加方便后续的分析,极大的节省了运算资源和时间。
事实上,由于这个数据集本身也就3822个细胞,Immugent上面说的Supercell可能大家感受不是很深。在随后一篇推文中,Immugent将会实操更大的一个数据集,敬请期待!
网友评论