ATACseqQC 1.12.5
Assay for Transposase-Accessible Chromatin using sequencing (ATAC-seq) is an alternative or complementary technique to MNase-seq, DNase-seq, and FAIRE-seq for chromatin accessibility analysis. The results obtained from ATAC-seq are similar to those from DNase-seq and FAIRE-seq. ATAC-seq is gaining popularity because it does not require cross-linking, has higher signal to noise ratio, requires a much smaller amount of biological material and is faster and easier to perform, compared to other techniques1.
To help researchers quickly assess the quality of ATAC-seq data, we have developed the ATACseqQC package for easily making diagnostic plots following the published guidelines1. In addition, it has functions to preprocess ATACseq data for subsequent peak calling.
Here is an example using ATACseqQC with a subset of published ATAC-seq data1. Currently, only bam input file format is supported.
First install ATACseqQC and other packages required to run the examples. Please note that the example dataset used here is from human. To run analysis with dataset from a different species or differnt assembly, please install the corresponding BSgenome, TxDb and phastCons. For example, to analyze mouse data aligned to mm10, please install BSgenome.Mmusculus.UCSC.mm10, TxDb.Mmusculus.UCSC.mm10.knownGene and phastCons60way.UCSC.mm10. Please note that phstCons60way.UCSC.mm10 is optional, which can be obtained according to the vignettes of GenomicScores.
library(BiocManager)
BiocManager::install(c("ATACseqQC", "ChIPpeakAnno", "MotifDb", "GenomicAlignments",
           "BSgenome.Hsapiens.UCSC.hg19", "TxDb.Hsapiens.UCSC.hg19.knownGene",
           "phastCons100way.UCSC.hg19"))## load the library
library(ATACseqQC)
## input the bamFile from the ATACseqQC package 
bamfile <- system.file("extdata", "GL1.bam", 
                        package="ATACseqQC", mustWork=TRUE)
bamfile.labels <- gsub(".bam", "", basename(bamfile))Source code of IGVSnapshot function is available in extdata folder. To call the function, please try
source(system.file("extdata", "IGVSnapshot.R", package = "ATACseqQC"))#bamQC(bamfile, outPath=NULL)
estimateLibComplexity(readsDupFreq(bamfile))First, there should be a large proportion of reads with less than 100 bp, which represents the nucleosome-free region. Second, the fragment size distribution should have a clear periodicity, which is evident in the inset figure, indicative of nucleosome occupacy (present in integer multiples).
## generate fragement size distribution
fragSize <- fragSizeDist(bamfile, bamfile.labels)Tn5 transposase has been shown to bind as a dimer and inserts two adaptors into accessible DNA locations separated by 9 bp2.
Therefore, for downstream analysis, such as peak-calling and footprinting,
all reads in input bamfile need to be shifted.
The function shiftGAlignmentsList can be used to shift the reads.
By default, all reads aligning to the positive strand are offset by +4bp,
and all reads aligning to the negative strand are offset by -5bp1.
The adjusted reads will be written into a new bamfile for peak calling or footprinting.
## bamfile tags to be read in
possibleTag <- combn(LETTERS, 2)
possibleTag <- c(paste0(possibleTag[1, ], possibleTag[2, ]),
                 paste0(possibleTag[2, ], possibleTag[1, ]))
library(Rsamtools)
bamTop100 <- scanBam(BamFile(bamfile, yieldSize = 100),
                     param = ScanBamParam(tag=possibleTag))[[1]]$tag
tags <- names(bamTop100)[lengths(bamTop100)==100]
tags## [1] "AS" "MD" "XG" "NM" "XM" "XN" "XO" "YS" "YT"## files will be output into outPath
outPath <- "splited"
dir.create(outPath)
## shift the coordinates of 5'ends of alignments in the bam file
library(BSgenome.Hsapiens.UCSC.hg19)
seqlev <- "chr1" ## subsample data for quick run
which <- as(seqinfo(Hsapiens)[seqlev], "GRanges")
gal <- readBamFile(bamfile, tag=tags, which=which, asMates=TRUE, bigFile=TRUE)
shiftedBamfile <- file.path(outPath, "shifted.bam")
gal1 <- shiftGAlignmentsList(gal, outbam=shiftedBamfile)PT score is calculated as the coverage of promoter divided by the coverage of its transcript body. PT score will show if the signal is enriched in promoters.
library(TxDb.Hsapiens.UCSC.hg19.knownGene)
txs <- transcripts(TxDb.Hsapiens.UCSC.hg19.knownGene)
pt <- PTscore(gal1, txs)
plot(pt$log2meanCoverage, pt$PT_score, 
     xlab="log2 mean coverage",
     ylab="Promoter vs Transcript")NFR score is a ratio between cut signal adjacent to TSS and that flanking the corresponding TSS. Each TSS window of 400 bp is first divided into 3 sub-regions: the most upstream 150 bp (n1), the most downstream of 150 bp (n2), and the middle 100 bp (nf). Then the number of fragments with 5’ ends overlapping each region are calculated for each TSS. The NFR score for each TSS is calculated as NFR-score = log2(nf) - log2((n1+n2)/2). A plot can be generated with the NFR scores as Y-axis and the average signals of 400 bp window as X-axis, very like a MA plot for gene expression data.
nfr <- NFRscore(gal1, txs)
plot(nfr$log2meanCoverage, nfr$NFR_score, 
     xlab="log2 mean coverage",
     ylab="Nucleosome Free Regions score",
     main="NFRscore for 200bp flanking TSSs",
     xlim=c(-10, 0), ylim=c(-5, 5))TSS enrichment score is a raio between aggregate distribution of reads centered on TSSs and that flanking the corresponding TSSs. TSS score = the depth of TSS (each 100bp window within 1000 bp each side) / the depth of end flanks (100bp each end). TSSE score = max(mean(TSS score in each window)). TSS enrichment score is calculated according to the definition at https://www.encodeproject.org/data-standards/terms/#enrichment. Transcription start site (TSS) enrichment values are dependent on the reference files used; cutoff values for high quality data are listed in the following table from https://www.encodeproject.org/atac-seq/.
tsse <- TSSEscore(gal1, txs)
tsse$TSSEscore## [1] 26.87021plot(100*(-9:10-.5), tsse$values, type="b", 
     xlab="distance to TSS",
     ylab="aggregate TSS score")The shifted reads will be split into different bins, namely nucleosome free, mononucleosome, dinucleosome, and trinucleosome. Shifted reads that do not fit into any of the above bins will be discarded. Splitting reads is a time-consuming step because we are using random forest to classify the fragments based on fragment length, GC content and conservation scores3.
By default, we assign the top 10% of short reads (reads below 100_bp) as nucleosome-free regions and the top 10% of intermediate length reads as (reads between 180 and 247 bp) mononucleosome. This serves as the training set to classify the rest of the fragments using random forest. The number of the tree will be set to 2 times of square root of the length of the training set.
library(phastCons100way.UCSC.hg19)
## run program for chromosome 1 only
txs <- txs[seqnames(txs) %in% "chr1"]
genome <- Hsapiens
## split the reads into NucleosomeFree, mononucleosome, 
## dinucleosome and trinucleosome.
## and save the binned alignments into bam files.
objs <- splitGAlignmentsByCut(gal1, txs=txs, genome=genome, outPath = outPath,
                              conservation=phastCons100way.UCSC.hg19)
## list the files generated by splitGAlignmentsByCut.
dir(outPath)##  [1] "NucleosomeFree.bam"     "NucleosomeFree.bam.bai" "dinucleosome.bam"      
##  [4] "dinucleosome.bam.bai"   "inter1.bam"             "inter1.bam.bai"        
##  [7] "inter2.bam"             "inter2.bam.bai"         "inter3.bam"            
## [10] "inter3.bam.bai"         "mononucleosome.bam"     "mononucleosome.bam.bai"
## [13] "others.bam"             "others.bam.bai"         "shifted.bam"           
## [16] "shifted.bam.bai"        "trinucleosome.bam"      "trinucleosome.bam.bai"You can also perform shifting, splitting and saving in one step by calling splitBam.
objs <- splitBam(bamfile, tags=tags, outPath=outPath,
                 txs=txs, genome=genome,
                 conservation=phastCons100way.UCSC.hg19)Conservation is an optional parameter. If you do not have the conservation score or you would like to simply split the bam files using the fragment length, then you will just need to run the command without providing the conservation argument. Without setting the conservation parameter, it will run much faster.
By averaging the signal across all active TSSs, we should observe that nucleosome-free fragments are enriched at the TSSs, whereas the nucleosome-bound fragments should be enriched both upstream and downstream of the active TSSs and display characteristic phasing of upstream and downstream nucleosomes. Because ATAC-seq reads are concentrated at regions of open chromatin, users should see a strong nucleosome signal at the +1 nucleosome, but the signal decreases at the +2, +3 and +4 nucleosomes.
library(ChIPpeakAnno)
bamfiles <- file.path(outPath,
                     c("NucleosomeFree.bam",
                     "mononucleosome.bam",
                     "dinucleosome.bam",
                     "trinucleosome.bam"))
## Plot the cumulative percentage of tag allocation in nucleosome-free 
## and mononucleosome bam files.
cumulativePercentage(bamfiles[1:2], as(seqinfo(Hsapiens)["chr1"], "GRanges"))TSS <- promoters(txs, upstream=0, downstream=1)
TSS <- unique(TSS)
## estimate the library size for normalization
(librarySize <- estLibSize(bamfiles))## splited/NucleosomeFree.bam splited/mononucleosome.bam 
##                      33854                       2025 
##   splited/dinucleosome.bam  splited/trinucleosome.bam 
##                       1972                        431## calculate the signals around TSSs.
NTILE <- 101
dws <- ups <- 1010
sigs <- enrichedFragments(gal=objs[c("NucleosomeFree", 
                                     "mononucleosome",
                                     "dinucleosome",
                                     "trinucleosome")], 
                          TSS=TSS,
                          librarySize=librarySize,
                          seqlev=seqlev,
                          TSS.filter=0.5,
                          n.tile = NTILE,
                          upstream = ups,
                          downstream = dws)
## log2 transformed signals
sigs.log2 <- lapply(sigs, function(.ele) log2(.ele+1))
#plot heatmap
featureAlignedHeatmap(sigs.log2, reCenterPeaks(TSS, width=ups+dws),
                      zeroAt=.5, n.tile=NTILE)## get signals normalized for nucleosome-free and nucleosome-bound regions.
out <- featureAlignedDistribution(sigs, 
                                  reCenterPeaks(TSS, width=ups+dws),
                                  zeroAt=.5, n.tile=NTILE, type="l", 
                                  ylab="Averaged coverage")## rescale the nucleosome-free and nucleosome signals to 0~1
range01 <- function(x){(x-min(x))/(max(x)-min(x))}
out <- apply(out, 2, range01)
matplot(out, type="l", xaxt="n", 
        xlab="Position (bp)", 
        ylab="Fraction of signal")
axis(1, at=seq(0, 100, by=10)+1, 
     labels=c("-1K", seq(-800, 800, by=200), "1K"), las=2)
abline(v=seq(0, 100, by=10)+1, lty=2, col="gray")ATAC-seq footprints infer factor occupancy genome-wide. The factorFootprints
function uses matchPWM to predict the binding sites using the input position
weight matrix (PWM).
Then it calculates and plots the accumulated coverage for those binding sites
to show the status of the occupancy genome-wide.
Unlike CENTIPEDE4, the footprints generated here
do not take the conservation (PhyloP) into consideration.
factorFootprints function could also accept the
binding sites as a GRanges object.
## foot prints
library(MotifDb)
CTCF <- query(MotifDb, c("CTCF"))
CTCF <- as.list(CTCF)
print(CTCF[[1]], digits=2)##      1    2    3    4    5    6     7     8     9      10    11      12      13
## A 0.17 0.23 0.29 0.10 0.33 0.06 0.052 0.037 0.023 0.00099 0.245 0.00099 0.00099
## C 0.42 0.28 0.30 0.32 0.11 0.33 0.562 0.005 0.960 0.99702 0.670 0.68901 0.99702
## G 0.25 0.23 0.26 0.27 0.42 0.55 0.052 0.827 0.013 0.00099 0.027 0.00099 0.00099
## T 0.16 0.27 0.15 0.31 0.14 0.06 0.334 0.131 0.004 0.00099 0.058 0.30900 0.00099
##      14    15    16    17      18    19   20
## A 0.050 0.253 0.004 0.172 0.00099 0.019 0.19
## C 0.043 0.073 0.418 0.150 0.00099 0.063 0.43
## G 0.017 0.525 0.546 0.055 0.99702 0.865 0.15
## T 0.890 0.149 0.032 0.623 0.00099 0.053 0.23sigs <- factorFootprints(shiftedBamfile, pfm=CTCF[[1]], 
                         genome=genome,
                         min.score="90%", seqlev=seqlev,
                         upstream=100, downstream=100)featureAlignedHeatmap(sigs$signal, 
                      feature.gr=reCenterPeaks(sigs$bindingSites,
                                               width=200+width(sigs$bindingSites[1])), 
                      annoMcols="score",
                      sortBy="score",
                      n.tile=ncol(sigs$signal[[1]]))sigs$spearman.correlation## $`+`
## 
##  Spearman's rank correlation rho
## 
## data:  predictedBindingSiteScore and highest.sig.windows
## S = 6179324, p-value = 1.241e-06
## alternative hypothesis: true rho is not equal to 0
## sample estimates:
##       rho 
## 0.2499378 
## 
## 
## $`-`
## 
##  Spearman's rank correlation rho
## 
## data:  predictedBindingSiteScore and highest.sig.windows
## S = 6521273, p-value = 5.731e-05
## alternative hypothesis: true rho is not equal to 0
## sample estimates:
##       rho 
## 0.2084312sigs$Profile.segmentation##           pos   distal_abun proximal_abun       binding 
##   51.75000000    0.08269190    0.11405437    0.06159158Here is the CTCF footprints for the full dataset.
V-plot is a plot to visualize fragment midpoint vs length for a given transcription factors.
vp <- vPlot(shiftedBamfile, pfm=CTCF[[1]], 
            genome=genome, min.score="90%", seqlev=seqlev,
            upstream=200, downstream=200, 
            ylim=c(30, 250), bandwidth=c(2, 1))distanceDyad(vp, pch=20, cex=.5)Here is the CTCF vPlot for the full dataset.
path <- system.file("extdata", package="ATACseqQC", mustWork=TRUE)
bamfiles <- dir(path, "*.bam$", full.name=TRUE)
gals <- lapply(bamfiles, function(bamfile){
               readBamFile(bamFile=bamfile, tag=character(0), 
                          which=GRanges("chr1", IRanges(1, 1e6)), 
                          asMates=FALSE)
         })
library(TxDb.Hsapiens.UCSC.hg19.knownGene)
txs <- transcripts(TxDb.Hsapiens.UCSC.hg19.knownGene)
library(GenomicAlignments)
plotCorrelation(GAlignmentsList(gals), txs, seqlev="chr1")sessionInfo()## R version 4.0.2 (2020-06-22)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 18.04.4 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.11-bioc/R/lib/libRblas.so
## LAPACK: /home/biocbuild/bbs-3.11-bioc/R/lib/libRlapack.so
## 
## locale:
##  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
##  [3] LC_TIME=en_US.UTF-8        LC_COLLATE=C              
##  [5] LC_MONETARY=en_US.UTF-8    LC_MESSAGES=en_US.UTF-8   
##  [7] LC_PAPER=en_US.UTF-8       LC_NAME=C                 
##  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
## [11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C       
## 
## attached base packages:
## [1] stats4    parallel  stats     graphics  grDevices utils     datasets 
## [8] methods   base     
## 
## other attached packages:
##  [1] GenomicAlignments_1.24.0               
##  [2] Rsamtools_2.4.0                        
##  [3] SummarizedExperiment_1.18.2            
##  [4] DelayedArray_0.14.1                    
##  [5] matrixStats_0.56.0                     
##  [6] MotifDb_1.30.0                         
##  [7] phastCons100way.UCSC.hg19_3.7.2        
##  [8] GenomicScores_2.0.0                    
##  [9] TxDb.Hsapiens.UCSC.hg19.knownGene_3.2.2
## [10] GenomicFeatures_1.40.1                 
## [11] AnnotationDbi_1.50.3                   
## [12] Biobase_2.48.0                         
## [13] BSgenome.Hsapiens.UCSC.hg19_1.4.3      
## [14] BSgenome_1.56.0                        
## [15] rtracklayer_1.48.0                     
## [16] ChIPpeakAnno_3.22.3                    
## [17] GenomicRanges_1.40.0                   
## [18] GenomeInfoDb_1.24.2                    
## [19] Biostrings_2.56.0                      
## [20] XVector_0.28.0                         
## [21] IRanges_2.22.2                         
## [22] ATACseqQC_1.12.5                       
## [23] S4Vectors_0.26.1                       
## [24] BiocGenerics_0.34.0                    
## [25] BiocStyle_2.16.0                       
## 
## loaded via a namespace (and not attached):
##   [1] colorspace_1.4-1              grImport2_0.2-0              
##   [3] seqinr_3.6-1                  ellipsis_0.3.1               
##   [5] futile.logger_1.4.3           base64enc_0.1-3              
##   [7] rGADEM_2.36.0                 bit64_4.0.5                  
##   [9] interactiveDisplayBase_1.26.3 splines_4.0.2                
##  [11] motifStack_1.32.1             knitr_1.29                   
##  [13] ade4_1.7-15                   splitstackshape_1.4.8        
##  [15] polynom_1.4-0                 seqLogo_1.54.3               
##  [17] GO.db_3.11.4                  dbplyr_1.4.4                 
##  [19] png_0.1-7                     graph_1.66.0                 
##  [21] shiny_1.5.0                   HDF5Array_1.16.1             
##  [23] BiocManager_1.30.10           compiler_4.0.2               
##  [25] httr_1.4.2                    assertthat_0.2.1             
##  [27] Matrix_1.2-18                 fastmap_1.0.1                
##  [29] lazyeval_0.2.2                limma_3.44.3                 
##  [31] later_1.1.0.1                 formatR_1.7                  
##  [33] htmltools_0.5.0               prettyunits_1.1.1            
##  [35] tools_4.0.2                   gtable_0.3.0                 
##  [37] glue_1.4.2                    GenomeInfoDbData_1.2.3       
##  [39] dplyr_1.0.2                   rappdirs_0.3.1               
##  [41] Rcpp_1.0.5                    vctrs_0.3.4                  
##  [43] multtest_2.44.0               xfun_0.16                    
##  [45] stringr_1.4.0                 mime_0.9                     
##  [47] lifecycle_0.2.0               ensembldb_2.12.1             
##  [49] XML_3.99-0.5                  idr_1.2                      
##  [51] AnnotationHub_2.20.2          edgeR_3.30.3                 
##  [53] scales_1.1.1                  zlibbioc_1.34.0              
##  [55] MASS_7.3-52                   hms_0.5.3                    
##  [57] promises_1.1.1                ProtGenerics_1.20.0          
##  [59] RBGL_1.64.0                   rhdf5_2.32.2                 
##  [61] AnnotationFilter_1.12.0       lambda.r_1.2.4               
##  [63] yaml_2.2.1                    curl_4.3                     
##  [65] memoise_1.1.0                 MotIV_1.44.0                 
##  [67] ggplot2_3.3.2                 biomaRt_2.44.1               
##  [69] stringi_1.4.6                 RSQLite_2.2.0                
##  [71] BiocVersion_3.11.1            randomForest_4.6-14          
##  [73] BiocParallel_1.22.0           rlang_0.4.7                  
##  [75] pkgconfig_2.0.3               bitops_1.0-6                 
##  [77] evaluate_0.14                 lattice_0.20-41              
##  [79] purrr_0.3.4                   Rhdf5lib_1.10.1              
##  [81] htmlwidgets_1.5.1             bit_4.0.4                    
##  [83] tidyselect_1.1.0              magrittr_1.5                 
##  [85] bookdown_0.20                 R6_2.4.1                     
##  [87] magick_2.4.0                  generics_0.0.2               
##  [89] DBI_1.1.0                     preseqR_4.0.0                
##  [91] pillar_1.4.6                  survival_3.2-3               
##  [93] RCurl_1.98-1.2                tibble_3.0.3                 
##  [95] crayon_1.3.4                  futile.options_1.0.1         
##  [97] KernSmooth_2.23-17            BiocFileCache_1.12.1         
##  [99] rmarkdown_2.3                 jpeg_0.1-8.1                 
## [101] progress_1.2.2                locfit_1.5-9.4               
## [103] grid_4.0.2                    data.table_1.13.0            
## [105] blob_1.2.1                    digest_0.6.25                
## [107] xtable_1.8-4                  VennDiagram_1.6.20           
## [109] httpuv_1.5.4                  regioneR_1.20.1              
## [111] munsell_0.5.0                 openssl_1.4.2                
## [113] askpass_1.11. Buenrostro, J. D., Giresi, P. G., Zaba, L. C., Chang, H. Y. & Greenleaf, W. J. Transposition of native chromatin for fast and sensitive epigenomic profiling of open chromatin, dna-binding proteins and nucleosome position. Nature methods 10, 1213–1218 (2013).
2. Adey, A. et al. Rapid, low-input, low-bias construction of shotgun fragment libraries by high-density in vitro transposition. Genome biology 11, R119 (2010).
3. Chen, K. et al. DANPOS: Dynamic analysis of nucleosome position and occupancy by sequencing. Genome research 23, 341–351 (2013).
4. Pique-Regi, R. et al. Accurate inference of transcription factor binding from dna sequence and chromatin accessibility data. Genome research 21, 447–455 (2011).