这是CUT&Tag数据分析的最后一部分,这一部分基本就是进行各种的可视化了。
第七节 可视化
通常,我们感兴趣的是使用基因组浏览器在各个区域可视化染色质landscape。Integrative Genomic Viewer提供了一个易于使用的网页应用程序版本和本地桌面版本。UCSC Genome Browser提供了最全面的补充基因组信息。
(一)查看标准化的bedgraph文件
根据官网展示的染色体位置区域,我们可以使用IGV也查看一下:hg38 ,chr7:131,000,000-134,000,000
下面是我运行后得到的IGV峰图:
再看一下官网的图:
基本上是一样的。
(二)热图可视化特异区域
我们还感兴趣的是在一系列的注释位点上观察染色质特征,例如基因启动子上的组蛋白修饰信号。我们将使用deepTools的computeMatrix和plotHeatmap函数来生成热图。
首先,我们要先把bam文件sort,生成其索引,在生成bw文件:
#!/bin/bash
projPath="/gpfs/home/fangy04/cut_tag"
cat /gpfs/home/fangy04/cut_tag/filenames | while read i
do
samtools sort -o $projPath/bam_files/${i}.sorted.bam $projPath/bam_files/${i}_bowtie2.mapped.bam
samtools index $projPath/bam_files/${i}.sorted.bam
bamCoverage -b $projPath/bam_files/${i}.sorted.bam -o $projPath/bigwig/${i}_raw.bw
done
(1)Heatmap over transcription units
这一步首先你要先下载hg38的基因注释文件,可以参考我之前的文章:ChIP-seq实践(非转录因子,非组蛋白)进行下载。然后运行(这一步非常非常耗时以及耗内存,我用了服务器上120G,运行了9个小时。。。):
#!/bin/bash
projPath="/gpfs/home/fangy04/cut_tag"
cores=8
computeMatrix scale-regions -S $projPath/bigwig/SH_Hs_K27m3_rep1_raw.bw \
$projPath/bigwig/SH_Hs_K27m3_rep2_raw.bw \
$projPath/bigwig/SH_Hs_K4m3_rep1_raw.bw \
$projPath/bigwig/SH_Hs_K4m3_rep2_raw.bw \
-R $projPath/data/hg38_genes.bed \ #这是我们下载的基因组注释文件,bed格式的
--beforeRegionStartLength 3000 \
--regionBodyLength 5000 \
--afterRegionStartLength 3000 \
--skipZeros -o $projPath/data/matrix_gene.mat.gz -p $cores
plotHeatmap -m $projPath/data/matrix_gene.mat.gz -out $projPath/data/Histone_gene.png --sortUsing sum --missingDataColor "#cc2200"
这里你可以看到上面的plotheatmap代码里,我使用了--missingDataColor "#cc2200"
这个参数,是因为你要指定画图的时候,你的missing data的颜色,如果你不指定,并且在computeMatrix代码里也没有指定--missingDataAsZero
,那么你画出来的图很有可能是这样的:
运行完成后生成两个文件:
-rw------- 1 fangy04 fangy04 2069525 Dec 25 03:08 Histone_gene.png
-rw------- 1 fangy04 fangy04 134316380 Dec 25 03:04 matrix_gene.mat.gz
(2)在CUT&Tag peaks上的热图
我们使用从SEACR返回的信号块的中点来对齐热图中的信号。SEACR输出的第六列是一个chr:start-end形式的条目,表示该区域信号最大的第一个和最后一个碱基的位置。我们首先在第6列中生成一个包含中点信息的bed文件,并使用deeptools进行热图可视化。
#!/bin/bash
projPath="/gpfs/home/fangy04/cut_tag"
cores=12
cat /gpfs/home/fangy04/cut_tag/filenames2 | while read i
do
awk '{split($6, summit, ":"); split(summit[2], region, "-"); print summit[1]"\t"region[1]"\t"region[2]}' $projPath/peak_calling/${i}_seacr_control.peaks.stringent.bed > $projPath/peak_calling/${i}_seacr_control.peaks.summitRegion.bed
computeMatrix reference-point -S $projPath/bigwig/${i}_raw.bw \
-R $projPath/peak_calling/${i}_seacr_control.peaks.summitRegion.bed \
--skipZeros -o $projPath/data/${i}_SEACR.mat.gz -p $cores \
-a 3000 -b 3000 --referencePoint center \
--missingDataAsZero #这次我加了这个参数,因为第一次按照官网的代码没有加这个参数,画出来的热图里很多黑色的线,很难看
plotHeatmap -m $projPath/data/${i}_SEACR.mat.gz -out $projPath/data/${i}_SEACR_heatmap.png --sortUsing sum --startLabel "Peak Start" --endLabel "Peak End" --xAxisLabel "" --regionsLabel "Peaks" --samplesLabel "${i}"
done
第八节 差异分析
评估来自高通量测序分析count数据的方差-均值依赖性和基于使用负二项分布的模型的差异表达测试。
(一)创建peak x sample矩阵
通常,差异检测比较相同组蛋白修饰的两种或多种条件。在本教程中,受演示数据的限制,我们将通过比较两个重复的H3K27me3和两个重复的H3K4me3来说明差异检测。我们将使用DESeq2 (complete tutorial)作为说明。
(1)创建主要peak列表,合并每个样品的peaks
> library(GenomicRanges)
> library(magrittr)
> mPeak = GRanges()
## overlap with bam file to get count
> histL = c("SH_Hs_K27m3", "SH_Hs_K4m3")
> repL = c("rep1","rep2")
> for(hist in histL){
for(rep in repL){
peakRes = read.table(paste0(hist, "_", rep, "_seacr_control.peaks.stringent.bed"), header = FALSE, fill = TRUE)
mPeak = GRanges(seqnames = peakRes$V1, IRanges(start = peakRes$V2, end = peakRes$V3), strand = "*") %>% append(mPeak, .)
}
}
> masterPeak = reduce(mPeak)
(2)在主要peak列表里获取每个peak的片段counts
> library(DESeq2)
# 这里官网的代码仍然是有问题的,不能直接用,需要自己加for语句
> for (hist in histL){
for(rep in repL){
countMat = matrix(NA, length(masterPeak), length(histL)*length(repL))
}
}
## overlap with bam file to get count
> library(chromVAR)
> i = 1
> for(hist in histL){
for(rep in repL){
bamFile = paste0(hist, "_", rep, "_bowtie2.mapped.bam")
fragment_counts <- getCounts(bamFile, masterPeak, paired = TRUE, by_rg = FALSE, format = "bam")
countMat[, i] = counts(fragment_counts)[,1]
i = i + 1
}
}
> colnames(countMat) = paste(rep(histL, 2), rep(repL, each = 2), sep = "_")
(二)测序深度标准化和差异富集peaks检测
> selectR = which(rowSums(countMat) > 5) ## remove low count genes
> dataS = countMat[selectR,]
> condition = factor(rep(histL, each = length(repL)))
> dds = DESeqDataSetFromMatrix(countData = dataS,
colData = DataFrame(condition),
design = ~ condition)
> DDS = DESeq(dds)
> normDDS = counts(DDS, normalized = TRUE) ## normalization with respect to the sequencing depth
> colnames(normDDS) = paste0(colnames(normDDS), "_norm")
> res = results(DDS, independentFiltering = FALSE, altHypothesis = "greaterAbs")
> countMatDiff = cbind(dataS, normDDS, res)
> head(countMatDiff)
DataFrame with 6 rows and 14 columns
SH_Hs_K27m3_rep1 SH_Hs_K4m3_rep1 SH_Hs_K27m3_rep2 SH_Hs_K4m3_rep2 SH_Hs_K27m3_rep1_norm SH_Hs_K4m3_rep1_norm
<numeric> <numeric> <numeric> <numeric> <numeric> <numeric>
1 3 4 5 4 0.748764 1.248831
2 0 0 298 198 0.000000 0.000000
3 0 1 173 91 0.000000 0.312208
4 0 0 266 206 0.000000 0.000000
5 4 3 0 2 0.998352 0.936623
6 4 2 0 1 0.998352 0.624415
SH_Hs_K27m3_rep2_norm SH_Hs_K4m3_rep2_norm baseMean log2FoldChange lfcSE stat pvalue padj
<numeric> <numeric> <numeric> <numeric> <numeric> <numeric> <numeric> <numeric>
1 19.9532 11.66190 8.40317 3.97867 1.06773 3.726287 1.94321e-04 3.08812e-03
2 1189.2085 577.26424 441.61819 14.06841 1.55908 9.023519 1.82142e-19 1.31189e-17
3 690.3795 265.30831 238.99999 11.73399 1.54086 7.615238 2.63205e-14 5.63249e-13
4 1061.5083 600.58805 415.52408 13.98064 1.54744 9.034672 1.64495e-19 1.20258e-17
5 0.0000 5.83095 1.94148 1.70735 1.82556 0.935247 3.49661e-01 9.53197e-01
6 0.0000 2.91548 1.13456 1.02468 2.28264 0.448903 6.53502e-01 9.53197e-01
(1)DESeq2要求输入矩阵应该是非标准化counts或测序reads的估计counts。
(2)DESeq2模型在内部修正文库大小。
(3)countMatDiff总结了差异分析结果:
前4列:在过滤低counts的峰区域后,原始reads计数
第二个4列:消除文库大小差异的标准化reads计数。
剩余列:差示检测结果。