劉小澤寫于19.10.23
筆記目的:根據(jù)生信技能樹的單細(xì)胞轉(zhuǎn)錄組課程探索Smartseq2技術(shù)及發(fā)育相關(guān)的分析
課程鏈接在:http://jm.grazy.cn/index/mulitcourse/detail.html?cid=55
這次會介紹文章的兩張主圖咆槽,還有上游分析尽纽,算是引言部分炊汤。對應(yīng)視頻第三單元1-4講
前言
這次要重復(fù)的文章是:Dissecting Cell Lineage Specification and Sex Fate Determination in Gonadal Somatic Cells Using Single-Cell Transcriptomics
文章方法思路
為了研究卵巢發(fā)育過程中體細(xì)胞譜系特征三妈,作者結(jié)合Fluidigm C1分選和smartseq2建庫史煎,在Tg(Nr5a1-GFP)轉(zhuǎn)基因小鼠性腺分化的6個(gè)時(shí)期(E10.5, E11.5, E12.5, E13.5, E16.5, and post-natalday6)提取了663個(gè)細(xì)胞(GSE119766)阔籽,然后使用Hiseq2000 進(jìn)行雙端100bp測序吱肌,每個(gè)細(xì)胞測10M reads。
經(jīng)過比對卷拘、定量得到表達(dá)矩陣喊废,然后對細(xì)胞進(jìn)行過濾,最后剩下563個(gè)栗弟。進(jìn)行PCA污筷,用
Jackstraw
提取了最顯著的幾個(gè)主成分,并用FactoMineR
進(jìn)行HCPC 聚類乍赫,使用Rtsne
進(jìn)行tSNE瓣蛀,然后分群,得到了4個(gè)胚胎發(fā)育時(shí)期(C1到C4)耿焊,之后對標(biāo)記基因進(jìn)行可視化(包括等高線圖和熱圖揪惦,使用了自己包裝的大量代碼)。然后對C1-C4每個(gè)群進(jìn)行差異分析(使用monocle2)罗侯,差異基因進(jìn)行功能注釋(使用clusterProfiler和PANTHER)
根據(jù)高變化基因進(jìn)行細(xì)胞譜系推斷,利用
diffusion map的Destiny
和Slingshot
溪猿。后來譜系發(fā)育基因進(jìn)行了可視化钩杰、聚類和注釋
綜上,文章得到了6個(gè)發(fā)育時(shí)期诊县、4群細(xì)胞讲弄、2個(gè)發(fā)育軌跡這三種細(xì)胞屬性
重要的信息如下:
分群信息(對應(yīng)課程下游分析之第5、6講)
標(biāo)記基因可視化(對應(yīng)課程下游分析之第7依痊、8講)
差異分析及注釋(對應(yīng)課程下游分析之第9避除、10講)
比較不同的差異分析方法,如monocle胸嘁、ROST(對應(yīng)課程下游分析之第11講)
譜系推斷(對應(yīng)課程下游分析之第12講)
譜系發(fā)育基因可視化(對應(yīng)課程下游分析之第13講)
譜系發(fā)育基因聚類和注釋(對應(yīng)課程下游分析之第14講)
上游分析
將會對應(yīng)課程的全部上游分析第1-4講
這部分和轉(zhuǎn)錄組分析很相似瓶摆,所以也是簡單帶過
smartseq2得到的文件和10X的不一樣,10X的數(shù)據(jù)雖然也有R1性宏、R2兩個(gè)數(shù)據(jù)群井,但第一個(gè)存儲的是barcode和UMI信息,而只有第二個(gè)才是真正的測序信息毫胜,也就是單端測序书斜;而smartseq2得到的兩個(gè)R1诬辈、R2都是測序信息,于是它的操作和我們常規(guī)bulk轉(zhuǎn)錄組是類似的荐吉”涸悖可以用hisat2+featureCounts進(jìn)行操作;或者如果不想比對的話样屠,也可以用salmon進(jìn)行操作
配置conda
# 安裝conda
wget https://mirrors.tuna.tsinghua.edu.cn/anaconda/miniconda/Miniconda3-latest-Linux-x86_64.sh
bash Miniconda3-latest-Linux-x86_64.sh
# 激活
source ~/.bashrc
# 添加鏡像
conda config --add channels r
conda config --add channels conda-forge
conda config --add channels bioconda
conda config --add channels https://mirrors.tuna.tsinghua.edu.cn/anaconda/pkgs/free
conda config --add channels https://mirrors.tuna.tsinghua.edu.cn/anaconda/cloud/conda-forge
conda config --add channels https://mirrors.tuna.tsinghua.edu.cn/anaconda/cloud/bioconda
conda config --set show_channel_urls yes
# 創(chuàng)建環(huán)境
conda create -n rna python=2
conda activate rna
conda install -y sra-tools trim-galore fastqc multiqc hisat2 samtools subread salmon qualimap
#注銷當(dāng)前的rna環(huán)境
# conda deactivate
下載數(shù)據(jù)
XX全部的數(shù)據(jù)比較大穿撮,數(shù)據(jù)在:https://www.ncbi.nlm.nih.gov/Traces/study/?acc=PRJNA490198&o=acc_s%3Aa
因此簡單下幾個(gè)體驗(yàn)一下就好,我這里選取了這些:
# wkd=/YOUR_PATH/
# cd $wkd/sra
# 這些數(shù)據(jù)全部都放在了EBI瞧哟,而不是NCBI
SRR7815790
SRR7815850
SRR7815870
SRR7815890
SRR7815910
SRR7815960
SRR7815980
SRR7816020
SRR7816100
SRR7816120
SRR7816130
SRR7816140
SRR7816160
如果prefetch + ascp
可以用的話混巧,那是最好,因?yàn)槟鞘亲钍∈碌南螺d辦法勤揩,而且不用管SRA數(shù)據(jù)是來自歐洲的EBI還是美國的NCBI咧党。如果出現(xiàn)了使用https
下載方式,而非快速的fasp
下載陨亡,可以看這個(gè):來吧傍衡,加速你的下載
需要注意EBI和NCBI的SRA數(shù)據(jù)存儲結(jié)構(gòu)有些區(qū)別:
NCBI的文件存在
ftp://ftp.ncbi.nlm.nih.gov/sra/sra-instant/reads/ByRun/sra/SRR/
-
EBI文件存在
ftp://ftp.sra.ebi.ac.uk/vol1/srr
例如要下載SRR7815792.sra,它就是
ftp://ftp.sra.ebi.ac.uk/vol1/srr/SRR781/002/SRR7815792
负蠕,倒數(shù)第二個(gè)位置的002
是和SRR ID的最后一個(gè)數(shù)字對應(yīng)的蛙埂,另外EBI下載的名稱沒有后綴.sra
sra2fq
wkd=/YOUR_PATH/
ls $wkd/sra/SRR* | while read i;do \
(fastq-dump --gzip --split-3 -A `basename $i` -O $wkd/rawdata $i &);done
下載參考數(shù)據(jù)
# 從Gencode下載參考基因組
wget ftp://ftp.ebi.ac.uk/pub/databases/gencode/Gencode_mouse/release_M23/GRCm38.primary_assembly.genome.fa.gz
# 從Gencode下載參考轉(zhuǎn)錄組
wget ftp://ftp.ebi.ac.uk/pub/databases/gencode/Gencode_mouse/release_M23/gencode.vM23.transcripts.fa.gz
# 下載GTF文件
wget ftp://ftp.ebi.ac.uk/pub/databases/gencode/Gencode_mouse/release_M23/gencode.vM23.annotation.gtf.gz
基于比對的hisat2流程
構(gòu)建索引
ref=$wkd/reference/mm10.fasta
hisat2-build -p 40 $ref hisat.mm10
# 歷時(shí):00:14:39
如果不想自己構(gòu)建索引,可以直接下載hisat官網(wǎng)數(shù)據(jù)
wget ftp://ftp.ccb.jhu.edu/pub/infphilo/hisat2/data/mm10.tar.gz
比對過程
# 以其中SRR7815790為例
index=$wkd/hisat/hisat.mm10
hisat2 -p 10 -x $index -1 SRR7815790_1.fastq.gz -2 SRR7815790_2.fastq.gz --new-summary -S SRR7815790_hisat.sam
samtools sort -O bam -@ 10 -o SRR7815790_hisat.bam SRR7815790_hisat.sam
samtools index -@ 10 -b SRR7815790_hisat.bam
比對結(jié)果
# 看到有一個(gè)細(xì)胞(SRR7816020)質(zhì)量不好遮糖,后面需要去除
SRR7815790.hisat.log: Overall alignment rate: 90.14%
SRR7815850.hisat.log: Overall alignment rate: 87.49%
SRR7815870.hisat.log: Overall alignment rate: 87.39%
SRR7815890.hisat.log: Overall alignment rate: 90.08%
SRR7815910.hisat.log: Overall alignment rate: 90.32%
SRR7815960.hisat.log: Overall alignment rate: 91.73%
SRR7815980.hisat.log: Overall alignment rate: 86.01%
SRR7816020.hisat.log: Overall alignment rate: 61.82%
SRR7816100.hisat.log: Overall alignment rate: 88.14%
SRR7816120.hisat.log: Overall alignment rate: 90.21%
SRR7816130.hisat.log: Overall alignment rate: 87.30%
SRR7816140.hisat.log: Overall alignment rate: 89.59%
SRR7816160.hisat.log: Overall alignment rate: 84.33%
SRR7815790.hisat.log:Execution time for SRR7815790 hisat and sam2bam : 115.350829 seconds
SRR7815850.hisat.log:Execution time for SRR7815850 hisat and sam2bam : 149.416581 seconds
SRR7815870.hisat.log:Execution time for SRR7815870 hisat and sam2bam : 218.976666 seconds
SRR7815890.hisat.log:Execution time for SRR7815890 hisat and sam2bam : 168.738353 seconds
SRR7815910.hisat.log:Execution time for SRR7815910 hisat and sam2bam : 214.020996 seconds
SRR7815960.hisat.log:Execution time for SRR7815960 hisat and sam2bam : 169.597353 seconds
SRR7815980.hisat.log:Execution time for SRR7815980 hisat and sam2bam : 146.707250 seconds
SRR7816020.hisat.log:Execution time for SRR7816020 hisat and sam2bam : 3.484966 seconds
SRR7816100.hisat.log:Execution time for SRR7816100 hisat and sam2bam : 131.300152 seconds
SRR7816120.hisat.log:Execution time for SRR7816120 hisat and sam2bam : 133.382700 seconds
SRR7816130.hisat.log:Execution time for SRR7816130 hisat and sam2bam : 124.014219 seconds
SRR7816140.hisat.log:Execution time for SRR7816140 hisat and sam2bam : 166.373111 seconds
SRR7816160.hisat.log:Execution time for SRR7816160 hisat and sam2bam : 209.587995 seconds
定量
gtf=$wkd/reference/gencode.vM23.annotation.gtf
featureCounts -T 10 -p -t exon -g gene_name -a $gtf -o $wkd/hisat/count/hisat2_counts.txt $wkd/hisat/*.bam 1>featureCounts.log 2>&1
不基于比對的salmon流程
salmon需要對轉(zhuǎn)錄本構(gòu)建索引绣的。因此只能使用參考轉(zhuǎn)錄組,而不能使用基因組
構(gòu)建索引
ref=$wkd/reference/gencode.vM23.transcripts.fa
salmon index -t $ref -i salmon.mm10
定量
# 以其中SRR7815790為例
index=$wkd/salmon/salmon.mm10
salmon quant -i $index -l A --validateMappings \
-1 SRR7815790_1.fastq.gz -2 SRR7815790_2.fastq.gz \
-p 10 -o SRR7815790_quant 1>SRR7815790.salmon.log 2>&1
運(yùn)行速度的確很快
SRR7815790.salmon.log:Execution time for SRR7815790 salmon : 36.016640 seconds
SRR7815850.salmon.log:Execution time for SRR7815850 salmon : 54.478129 seconds
SRR7815870.salmon.log:Execution time for SRR7815870 salmon : 76.499805 seconds
SRR7815890.salmon.log:Execution time for SRR7815890 salmon : 58.166234 seconds
SRR7815910.salmon.log:Execution time for SRR7815910 salmon : 56.277339 seconds
SRR7815960.salmon.log:Execution time for SRR7815960 salmon : 52.918936 seconds
SRR7815980.salmon.log:Execution time for SRR7815980 salmon : 47.993982 seconds
SRR7816020.salmon.log:Execution time for SRR7816020 salmon : 8.981974 seconds
SRR7816100.salmon.log:Execution time for SRR7816100 salmon : 40.505802 seconds
SRR7816120.salmon.log:Execution time for SRR7816120 salmon : 52.856553 seconds
SRR7816130.salmon.log:Execution time for SRR7816130 salmon : 38.405255 seconds
SRR7816140.salmon.log:Execution time for SRR7816140 salmon : 53.823648 seconds
SRR7816160.salmon.log:Execution time for SRR7816160 salmon : 75.848338 seconds
Salmon的結(jié)果和Hisat的不同欲账,它的每個(gè)數(shù)據(jù)都是獨(dú)立的文件夾屡江,其中quant.sf
就是每個(gè)樣本的定量結(jié)果
對于salmon的定量結(jié)果,需要用到R里面的tximport
導(dǎo)入
tximport
函數(shù)主要需要兩個(gè)參數(shù):定量文件files
和轉(zhuǎn)錄本與基因名的對應(yīng)文件tx2gene
rm(list = ls())
options(stringsAsFactors = F)
####################
# 配置files路徑
####################
dir <- file.path(getwd(),'quant/')
dir
files <- list.files(pattern = '*sf',dir,recursive = T)
files <- file.path(dir,files)
all(file.exists(files))
####################
# 配置tx2gene
####################
# https://support.bioconductor.org/p/101156/
# BiocManager::install("EnsDb.Mmusculus.v79")
# 如何構(gòu)建赛不?
if(F){
library(EnsDb.Mmusculus.v79)
txdf <- transcripts(EnsDb.Mmusculus.v79, return.type="DataFrame")
mm10_tx2gene <- as.data.frame(txdf[,c("tx_id", "gene_id")])
head(mm10_tx2gene)
write.csv(mm10_tx2gene,file = 'mm10_tx2gene.csv')
}
tx2_gene_file <- 'mm10_tx2gene.csv'
tx2gene <- read.csv(tx2_gene_file,row.names = 1)
head(tx2gene)
####################
# 開始整合
####################
library(tximport)
library(readr)
txi <- tximport(files, type = "salmon", tx2gene = tx2gene,ignoreTxVersion = T)
names(txi)
head(txi$length)
head(txi$counts)
# 發(fā)現(xiàn)目前counts的列名還沒有指定
####################
# 添加列名
####################
# 獲取導(dǎo)入文件名稱的ID惩嘉,如SRR7815870
library(stringr)
# 先得到SRRxxxx_quant這一部分
n1 <- sapply(strsplit(files,'\\/'), function(x)x[12])
# 再得到SRRxxxx這一部分
n2 <- sapply(strsplit(n1,'_'), function(x)x[1])
colnames(txi$counts) <- n2
head(txi$counts)
####################
# 操作新得到的表達(dá)矩陣
####################
salmon_expr <- txi$counts
# 表達(dá)量取整
salmon_expr <- apply(salmon_expr, 2, as.integer)
head(salmon_expr)
# 添加行名
rownames(salmon_expr) <- rownames(txi$counts)
dim(salmon_expr)
save(salmon_expr,file = 'salmon-aggr.Rdata')
好,現(xiàn)在有了salmon和featureCounts兩種方法得到的矩陣踢故,就可以來比較一下
rm(list = ls())
options(stringsAsFactors = F)
load('salmon-aggr.Rdata')
dim(salmon_expr)
colnames(salmon_expr)
salmon_expr[1:3,1:3]
# 為了方便比較文黎,我們選第一個(gè)樣本SRR7815790
salmon_SRR7815790 <- salmon_expr[,1]
names(salmon_SRR7815790) <- rownames(salmon_expr)
###########################
# 然后找featureCounts結(jié)果
###########################
ft <- read.table('../hisat/hisat2_counts.txt',row.names = 1,comment.char = '#',header = T)
ft[1:4,1:4]
colnames(ft)
# 兩種取子集的方法,grep返回結(jié)果的序號殿较;grepl返回邏輯值
ft_SRR7815790 <- ft[,grep(colnames(salmon_expr)[1], colnames(ft))]
ft_SRR7815790 <- ft[,grepl(colnames(salmon_expr)[1], colnames(ft))]
names(ft_SRR7815790) <- rownames(ft)
###########################
# 取salmon和featureCounts公共基因
###########################
# salmon使用的Ensembl基因耸峭,而featureCounts得到的是Symbol基因
# 先進(jìn)行基因名轉(zhuǎn)換
library(org.Mm.eg.db)
columns(org.Mm.eg.db)
gene_tr <- clusterProfiler::bitr(names(salmon_SRR7815790),
"ENSEMBL","SYMBOL",
org.Mm.eg.db)
# 要找salmon在gene_tr中的對應(yīng)位置,然后取gene_tr的第二列symbol斜脂,因此match中把salmon放第一個(gè)位置
names(salmon_SRR7815790) <- gene_tr[match(names(salmon_SRR7815790),gene_tr$ENSEMBL),2]
# 找共有基因
uni_gene <- intersect(names(salmon_SRR7815790),names(ft_SRR7815790))
length(uni_gene)
plot(log1p(salmon_SRR7815790[uni_gene]),
log1p(ft_SRR7815790[uni_gene]))