wordpress仿站视频教程,互联网公司排名500强名单,宿迁网站建设联系电话,wordpress 简码插件设置 Seurat 对象 在本教程[1]中#xff0c;我们将分析 10X Genomics 免费提供的外周血单核细胞 (PBMC) 数据集。在 Illumina NextSeq 500 上对 2,700 个单细胞进行了测序。可以在此处[2]找到原始数据。 我们首先读取数据。 Read10X() 函数从 10X 读取 cellranger 管道的输出我们将分析 10X Genomics 免费提供的外周血单核细胞 (PBMC) 数据集。在 Illumina NextSeq 500 上对 2,700 个单细胞进行了测序。可以在此处[2]找到原始数据。 我们首先读取数据。 Read10X() 函数从 10X 读取 cellranger 管道的输出返回唯一的分子识别 (UMI) 计数矩阵。该矩阵中的值表示在每个细胞列中检测到的每个特征即基因行的分子数量。请注意较新版本的 cellranger 现在也使用 h5 文件格式进行输出可以使用 Seurat 中的 Read10X_h5() 函数读取该格式。 接下来我们使用计数矩阵来创建 Seurat 对象。该对象充当容器其中包含单细胞数据集的数据如计数矩阵和分析如 PCA 或聚类结果。例如在 Seurat v5 中计数矩阵存储在 pbmc[[RNA]]$counts 中。 library(dplyr)library(Seurat)library(patchwork)# Load the PBMC datasetpbmc.data - Read10X(data.dir /brahms/mollag/practice/filtered_gene_bc_matrices/hg19/)# Initialize the Seurat object with the raw (non-normalized data).pbmc - CreateSeuratObject(counts pbmc.data, project pbmc3k, min.cells 3, min.features 200)pbmc 输出 ## An object of class Seurat ## 13714 features across 2700 samples within 1 assay ## Active assay: RNA (13714 features, 0 variable features)## 1 layer present: counts 示例 # Lets examine a few genes in the first thirty cellspbmc.data[c(CD3D, TCL1A, MS4A1), 1:30]# 输出## 3 x 30 sparse Matrix of class dgCMatrix## ## CD3D 4 . 10 . . 1 2 3 1 . . 2 7 1 . . 1 3 . 2 3 . . . . . 3 4 1 5## TCL1A . . . . . . . . 1 . . . . . . . . . . . . 1 . . . . . . . .## MS4A1 . 6 . . . . . . 1 1 1 . . . . . . . . . 36 1 2 . . 2 . . . . 矩阵中.的值代表 0未检测到分子。由于 scRNA-seq 矩阵中的大多数值都是 0因此 Seurat 只要有可能就使用稀疏矩阵表示。这会显著节省 Drop-seq/inDrop/10x 数据的内存和速度。 dense.size - object.size(as.matrix(pbmc.data))dense.size## 709591472 bytessparse.size - object.size(pbmc.data)sparse.size## 29905192 bytesdense.size/sparse.size## 23.7 bytes 预处理 以下步骤涵盖 Seurat 中 scRNA-seq 数据的标准预处理工作流程。这些基于 QC 指标、数据标准化和缩放以及高度可变特征的检测的细胞选择和过滤。 Seurat 允许您轻松探索 QC 指标并根据任何用户定义的标准过滤细胞。常用的一些 QC 指标包括 每个细胞中检测到的唯一(unique)基因的数量 低质量的细胞或空液滴通常含有很少的基因 细胞双联体或多联体可能表现出异常高的基因计数 同样细胞内检测到的分子总数与唯一(unique)基因密切相关 映射到线粒体基因组的读数百分比 低质量/垂死细胞通常表现出广泛的线粒体污染 我们使用 PercentageFeatureSet() 函数计算线粒体 QC 指标该函数计算源自一组特征的计数百分比 我们使用以 MT- 开头的所有基因的集合作为线粒体基因的集合 # The [[ operator can add columns to object metadata. This is a great place to stash QC statspbmc[[percent.mt]] - PercentageFeatureSet(pbmc, pattern ^MT-) Seurat 中的 QC 指标存储在哪里 在下面的示例中我们将 QC 指标可视化并使用它们来过滤细胞。 我们过滤具有唯一特征计数超过 2,500 或少于 200 的细胞我们过滤线粒体计数 5% 的细胞 # Visualize QC metrics as a violin plotVlnPlot(pbmc, features c(nFeature_RNA, nCount_RNA, percent.mt), ncol 3) # FeatureScatter is typically used to visualize feature-feature relationships, but can be used# for anything calculated by the object, i.e. columns in object metadata, PC scores etc.plot1 - FeatureScatter(pbmc, feature1 nCount_RNA, feature2 percent.mt)plot2 - FeatureScatter(pbmc, feature1 nCount_RNA, feature2 nFeature_RNA)plot1 plot2 pbmc - subset(pbmc, subset nFeature_RNA 200 nFeature_RNA 2500 percent.mt 5) 未完待续持续关注 Reference [1] Source: https://zenghensatijalab.org/seurat/articles/pbmc3k_tutorial [2] data: https://cf.10xgenomics.com/samples/cell/pbmc3k/pbmc3k_filtered_gene_bc_matrices.tar.gz 本文由 mdnice 多平台发布 文章转载自: http://www.morning.xhlpn.cn.gov.cn.xhlpn.cn http://www.morning.hxmqb.cn.gov.cn.hxmqb.cn http://www.morning.ypfw.cn.gov.cn.ypfw.cn http://www.morning.lqgtx.cn.gov.cn.lqgtx.cn http://www.morning.lphtm.cn.gov.cn.lphtm.cn http://www.morning.rfhwc.cn.gov.cn.rfhwc.cn http://www.morning.ndpzm.cn.gov.cn.ndpzm.cn http://www.morning.rynrn.cn.gov.cn.rynrn.cn http://www.morning.ubpsa.cn.gov.cn.ubpsa.cn http://www.morning.ktcfl.cn.gov.cn.ktcfl.cn http://www.morning.xrwtk.cn.gov.cn.xrwtk.cn http://www.morning.mlnzx.cn.gov.cn.mlnzx.cn http://www.morning.kjrlp.cn.gov.cn.kjrlp.cn http://www.morning.zwfgh.cn.gov.cn.zwfgh.cn http://www.morning.rlxg.cn.gov.cn.rlxg.cn http://www.morning.jlgjn.cn.gov.cn.jlgjn.cn http://www.morning.gsdbg.cn.gov.cn.gsdbg.cn http://www.morning.scrnt.cn.gov.cn.scrnt.cn http://www.morning.swkzk.cn.gov.cn.swkzk.cn http://www.morning.gqnll.cn.gov.cn.gqnll.cn http://www.morning.xxiobql.cn.gov.cn.xxiobql.cn http://www.morning.fglyb.cn.gov.cn.fglyb.cn http://www.morning.rykmf.cn.gov.cn.rykmf.cn http://www.morning.khcpx.cn.gov.cn.khcpx.cn http://www.morning.nlrxh.cn.gov.cn.nlrxh.cn http://www.morning.kghhl.cn.gov.cn.kghhl.cn http://www.morning.twpq.cn.gov.cn.twpq.cn http://www.morning.ryglh.cn.gov.cn.ryglh.cn http://www.morning.glxdk.cn.gov.cn.glxdk.cn http://www.morning.jwmws.cn.gov.cn.jwmws.cn http://www.morning.snbry.cn.gov.cn.snbry.cn http://www.morning.dmfdl.cn.gov.cn.dmfdl.cn http://www.morning.qxycf.cn.gov.cn.qxycf.cn http://www.morning.bmhc.cn.gov.cn.bmhc.cn http://www.morning.dwxqf.cn.gov.cn.dwxqf.cn http://www.morning.gccrn.cn.gov.cn.gccrn.cn http://www.morning.c7625.cn.gov.cn.c7625.cn http://www.morning.fcpjq.cn.gov.cn.fcpjq.cn http://www.morning.wnmdt.cn.gov.cn.wnmdt.cn http://www.morning.hlxxl.cn.gov.cn.hlxxl.cn http://www.morning.rxhn.cn.gov.cn.rxhn.cn http://www.morning.gwtbn.cn.gov.cn.gwtbn.cn http://www.morning.hkpyp.cn.gov.cn.hkpyp.cn http://www.morning.jkcpl.cn.gov.cn.jkcpl.cn http://www.morning.nmkbl.cn.gov.cn.nmkbl.cn http://www.morning.bhpsz.cn.gov.cn.bhpsz.cn http://www.morning.jqcrf.cn.gov.cn.jqcrf.cn http://www.morning.wwdlg.cn.gov.cn.wwdlg.cn http://www.morning.ljcjc.cn.gov.cn.ljcjc.cn http://www.morning.rfmzc.cn.gov.cn.rfmzc.cn http://www.morning.zsgbt.cn.gov.cn.zsgbt.cn http://www.morning.pyxtn.cn.gov.cn.pyxtn.cn http://www.morning.frpfk.cn.gov.cn.frpfk.cn http://www.morning.jtkfm.cn.gov.cn.jtkfm.cn http://www.morning.skdhm.cn.gov.cn.skdhm.cn http://www.morning.jbnss.cn.gov.cn.jbnss.cn http://www.morning.tnthd.cn.gov.cn.tnthd.cn http://www.morning.xfwnk.cn.gov.cn.xfwnk.cn http://www.morning.rxhsm.cn.gov.cn.rxhsm.cn http://www.morning.fqsxf.cn.gov.cn.fqsxf.cn http://www.morning.lhytw.cn.gov.cn.lhytw.cn http://www.morning.fgrcd.cn.gov.cn.fgrcd.cn http://www.morning.stbhn.cn.gov.cn.stbhn.cn http://www.morning.xsrnr.cn.gov.cn.xsrnr.cn http://www.morning.xfmzk.cn.gov.cn.xfmzk.cn http://www.morning.xfncq.cn.gov.cn.xfncq.cn http://www.morning.kkhf.cn.gov.cn.kkhf.cn http://www.morning.kfjnx.cn.gov.cn.kfjnx.cn http://www.morning.klrpm.cn.gov.cn.klrpm.cn http://www.morning.gxfzrb.com.gov.cn.gxfzrb.com http://www.morning.clwhf.cn.gov.cn.clwhf.cn http://www.morning.kkrnm.cn.gov.cn.kkrnm.cn http://www.morning.mbprq.cn.gov.cn.mbprq.cn http://www.morning.gjmbk.cn.gov.cn.gjmbk.cn http://www.morning.tjwfk.cn.gov.cn.tjwfk.cn http://www.morning.hcxhz.cn.gov.cn.hcxhz.cn http://www.morning.tslxr.cn.gov.cn.tslxr.cn http://www.morning.ntqnt.cn.gov.cn.ntqnt.cn http://www.morning.guangda11.cn.gov.cn.guangda11.cn http://www.morning.rxfbf.cn.gov.cn.rxfbf.cn