Seurat24式太极拳之3白鹤亮翅---空间转录组整合单细胞转录组数据

三、白鹤亮翅
稍右转体 跟步抱球 后坐转体 虚步分手

与单细胞数据集成

在〜50um时,来自于病毒测定的斑点将涵盖多个细胞的表达谱。对于可获得scRNA-seq数据的系统列表不断增加,用户可能有兴趣对每个空间体素进行“反卷积”以预测细胞类型的潜在组成。在准备此小插图时,我们使用了参考scRNA-seq数据集测试了多种decovonlution和整合方法使用SMART-Seq2协议生成的来自Allen Institute的约14,000个成年小鼠皮质细胞分类学。我们一直发现使用积分方法(而不是反卷积方法)具有更好的性能,这可能是由于表征空间和单细胞数据集的噪声模型存在很大差异,并且积分方法专门设计为对这些差异具有鲁棒性。因此,我们应用了Seurat v3中引入的基于“锚”的集成工作流,该工作流使注释能够从引用到查询集的概率传输。因此,我们利用sctransform归一化方法遵循此处介绍的标签传输工作流程,但期望开发出新方法来完成此任务。

我们首先加载数据(可在此处下载),对scRNA-seq参考进行预处理,然后执行标签转移。该过程为每个点输出每个scRNA-seq派生类的概率分类。我们将这些预测添加为Seurat对象中的一项新分析。

allen_reference <- readRDS("../data/allen_cortex.rds")
# note that setting ncells=3000 normalizes the full dataset but learns noise models on 3k cells
# this speeds up SCTransform dramatically with no loss in performance
library(dplyr)
allen_reference <- SCTransform(allen_reference, ncells = 3000, verbose = FALSE) %>% RunPCA(verbose = FALSE) %>% 
    RunUMAP(dims = 1:30)
# After subsetting, we renormalize cortex
cortex <- SCTransform(cortex, assay = "Spatial", verbose = FALSE) %>% RunPCA(verbose = FALSE)
# the annotation is stored in the 'subclass' column of object metadata
DimPlot(allen_reference, group.by = "subclass", label = TRUE)
image
anchors <- FindTransferAnchors(reference = allen_reference, query = cortex, normalization.method = "SCT")
predictions.assay <- TransferData(anchorset = anchors, refdata = allen_reference$subclass, prediction.assay = TRUE, 
    weight.reduction = cortex[["pca"]], dims = 1:30)
cortex[["predictions"]] <- predictions.assay

现在,我们获得了每个班级每个地点的预测分数。在额叶皮层区域中特别令人感兴趣的是层状兴奋性神经元。在这里,我们可以区分这些神经元亚型的不同顺序层,例如:

DefaultAssay(cortex) <- "predictions"
SpatialFeaturePlot(cortex, features = c("L2/3 IT", "L4"), pt.size.factor = 1.6, ncol = 2, crop = TRUE)
image.png

基于这些预测分数,我们还可以预测位置受空间限制的单元格类型。我们使用基于标记点过程的相同方法来定义空间可变特征,但将细胞类型预测得分用作“标记”而不是基因表达。

cortex <- FindSpatiallyVariableFeatures(cortex, assay = "predictions", selection.method = "markvariogram", 
    features = rownames(cortex), r.metric = 5, slot = "data")
top.clusters <- head(SpatiallyVariableFeatures(cortex), 4)
SpatialPlot(object = cortex, features = top.clusters, ncol = 2)
image.png

最后,我们证明我们的整合程序能够恢复神经元和非神经元子集(包括层状兴奋性,第1层星形胶质细胞和皮质灰质)的已知空间定位模式。

SpatialFeaturePlot(cortex, features = c("Astro", "L2/3 IT", "L4", "L5 PT", "L5 IT", "L6 CT", "L6 IT", 
    "L6b", "Oligo"), pt.size.factor = 1, ncol = 2, crop = FALSE, alpha = c(0.1, 1))
image.png

你可能感兴趣的:(Seurat24式太极拳之3白鹤亮翅---空间转录组整合单细胞转录组数据)