In this vignette, we provide a brief overview of the ChIPexoQual package. This package provides a statistical quality control (QC) pipeline that enables the exploration and analysis of ChIP-exo/nexus experiments. In this vignette we used the reads aligned to chr1 in the mouse liver ChIP-exo experiment (Serandour et al. 2013) to illustrate the use of the pipeline. To load the packages we use:
    library(ChIPexoQual)
    library(ChIPexoQualExample)ChIPexoQual takes a set of aligned reads from a ChIP-exo (or ChIP-nexus) experiment as input and performs the following steps:
We analyzed a larger collection of ChIP-exo/nexus experiments in (Welch et al. 2016) including complete versions of this samples.
The minimum input to use ChIPexoQual are the aligned reads of a ChIP-exo/nexus experiment. ChIPexoQual accepts either the name of the bam file or the reads in a GAlignments object:
    files = list.files(system.file("extdata",
        package = "ChIPexoQualExample"),full.names = TRUE)
    basename(files[1])## [1] "ChIPexo_carroll_FoxA1_mouse_rep1_chr1.bam"    ex1 = ExoData(file = files[1],mc.cores = 2L,verbose = FALSE)
    ex1## ExoData object with 655785 ranges and 11 metadata columns:
##            seqnames              ranges strand |  fwdReads  revReads    fwdPos
##               <Rle>           <IRanges>  <Rle> | <integer> <integer> <integer>
##        [1]     chr1     3000941-3000976      * |         2         0         1
##        [2]     chr1     3001457-3001492      * |         0         1         0
##        [3]     chr1     3001583-3001618      * |         0         2         0
##        [4]     chr1     3001647-3001682      * |         1         0         1
##        [5]     chr1     3001852-3001887      * |         1         0         1
##        ...      ...                 ...    ... .       ...       ...       ...
##   [655781]     chr1 197192012-197192047      * |         0         1         0
##   [655782]     chr1 197192421-197192456      * |         0         1         0
##   [655783]     chr1 197193059-197193094      * |         1         0         1
##   [655784]     chr1 197193694-197193729      * |         0         3         0
##   [655785]     chr1 197194986-197195021      * |         0         2         0
##               revPos     depth uniquePos       ARC       URC       FSR
##            <integer> <integer> <integer> <numeric> <numeric> <numeric>
##        [1]         0         2         1 0.0555556       0.5         1
##        [2]         1         1         1 0.0277778       1.0         0
##        [3]         1         2         1 0.0555556       0.5         0
##        [4]         0         1         1 0.0277778       1.0         1
##        [5]         0         1         1 0.0277778       1.0         1
##        ...       ...       ...       ...       ...       ...       ...
##   [655781]         1         1         1 0.0277778  1.000000         0
##   [655782]         1         1         1 0.0277778  1.000000         0
##   [655783]         0         1         1 0.0277778  1.000000         1
##   [655784]         1         3         1 0.0833333  0.333333         0
##   [655785]         1         2         1 0.0555556  0.500000         0
##                    M         A
##            <numeric> <numeric>
##        [1]      -Inf       Inf
##        [2]      -Inf      -Inf
##        [3]      -Inf      -Inf
##        [4]      -Inf       Inf
##        [5]      -Inf       Inf
##        ...       ...       ...
##   [655781]      -Inf      -Inf
##   [655782]      -Inf      -Inf
##   [655783]      -Inf       Inf
##   [655784]      -Inf      -Inf
##   [655785]      -Inf      -Inf
##   -------
##   seqinfo: 1 sequence from an unspecified genome; no seqlengths    reads = readGAlignments(files[1],param = NULL)
    ex2 = ExoData(reads = reads,mc.cores = 2L,verbose = FALSE)
    identical(GRanges(ex1),GRanges(ex2))## [1] FALSEFor the rest of the vignette, we generate an ExoData object for each replicate:
    files = files[grep("bai",files,invert = TRUE)] ## ignore index files
    exampleExoData = lapply(files,ExoData,mc.cores = 2L,verbose = FALSE)Finally, we can recover the number of reads that compose a ExoData object by using the nreads function:
    sapply(exampleExoData,nreads)## [1] 1654985 1766665 1670117To create the ARC vs URC plot proposed in (Welch et al. 2016), we use the ARC_URC_plot function. This function allows to visually compare different samples:
    ARCvURCplot(exampleExoData,names.input = paste("Rep",1:3,sep = "-"))This plot typically exhibits one of the following three patterns for any given sample. In all three panels we can observe two arms: the first with low Average Read Coefficient (ARC) and varying Unique Read Coefficient (URC); and the second where the URC decreases as the ARC increases. The first and third replicates exhibit a defined decreasing trend in URC as the ARC increases. This indicates that these samples exhibit a higher ChIP enrichment than the second replicate. On the other hand, the overall URC level from the first two replicates is higher than that of the third replicate, elucidating that the libraries for the first two replicates are more complex than that of the third replicate.
To create the FSR distribution and Region Composition plots suggested in Welch et. al 2016 (submitted), we use the FSR_dist_plot and region_comp_plot, respectively.
    p1 = regionCompplot(exampleExoData,names.input = paste("Rep",1:3,
        sep = "-"),depth.values = seq_len(50))
    p2 = FSRDistplot(exampleExoData,names.input = paste("Rep",1:3,sep = "-"),
        quantiles = c(.25,.5,.75),depth.values = seq_len(100))
    gridExtra::grid.arrange(p1,p2,nrow = 1)The left panel displays the Region Composition plot and the right panel shows the Forward Strand Ratio (FSR) distribution plot, both of which highlight specific problems with replicates 2 and 3. The Region Composition plot exhibits apparent decreasing trends in the proportions of regions formed by fragments in one exclusive strand. High quality experiments tend to show exponential decay in the proportion of single stranded regions, while for the lower quality experiments, the trend may be linear or even constant. The FSR distributions of both of replicates 2 and 3 are more spread around their respective medians. The rate at which the FSR distribution becomes more centralized around the median indicates the aforementioned lower enrichment in the second replicate and the low complexity in the third one. The asymmetric behavior of the second replicate is characteristic of low enrichment, while the constant values of replicate three for low minimum number of reads indicate that this replicate has islands composed of reads aligned to very few unique positions.
All the plot functions in ChIPexoQual allow a list or several separate ExoData objects. This allows to explore island subsets for each replicate. For example, to show that the first arm is composed of regions formed by reads aligned to few positions, we can generate the following plot:
    ARCvURCplot(exampleExoData[[1]],
                 subset(exampleExoData[[1]],uniquePos > 10),
                 subset(exampleExoData[[1]],uniquePos > 20),
                 names.input = c("All", "uniquePos > 10", "uniquePos > 20"))For this figure, we used the ARC vs URC plot to show how several of the regions with low ARC values are composed by reads that align to a small number of unique positions. This technique highlights a strategy that can be followed to further explore the data, as with all the previously listed plotting functions we may compare different subsets of the islands in the partition.
The last step of the quality control pipeline is to evaluate the linear model:
\[ \begin{align*} D_i = \beta_1 U_i + \beta_2 U_2 + \epsilon_i, \end{align*} \]
The distribution of the parameters of this model is built by sampling nregions regions (the default value is 1,000), fitting the model and repeating the process ntimes (the default value is 100). We visualize the distributions of the parameters with box-plots:
    p1 = paramDistBoxplot(exampleExoData,which.param = "beta1", names.input = paste("Rep",1:3,sep = "-"))
    p2 = paramDistBoxplot(exampleExoData,which.param = "beta2", names.input = paste("Rep",1:3,sep = "-"))
    gridExtra::grid.arrange(p1,p2,nrow = 1)Further details over this analysis are in Welch et. al 2016 (submitted). In short, when the ChIP-exo/nexus sample is not deeply sequenced, high values of \(\hat{\beta}_1\) indicate that the library complexity is low. In contrast, lower values correspond to higher quality ChIP-exo experiments. We concluded that samples with estimated \(\hat{\beta_1} \leq 10\) seem to be high quality samples. Similarly, samples with estimated \(\hat{\beta_2} \approx 0\) can be considered as high quality samples. The estimated values for these parameters can be accessed with the beta1, beta2, and param_dist methods. For example, using the median to summarize these parameter distributions, we conclude that these three replicates (in chr1) are high quality samples:
    sapply(exampleExoData,function(x)median(beta1(x)))## [1] 1.925876 1.488917 8.145535    sapply(exampleExoData,function(x)median(-beta2(x)))## [1] 0.016640335 0.008721185 0.045939732The behavior of the third’s FoxA1 replicate may be an indication of problems in the sample. However, it is also common to observe that pattern in deeply sequenced experiments. For convenience, we added the function ExoDataSubsampling, that performs the analysis suggested by Welch et. al 2016 (submitted) when the experiment is deeply sequenced. To use this function, we proceed as follows:
    sample.depth = seq(1e5,2e5,5e4)
    exoList = ExoDataSubsampling(file = files[3],sample.depth = sample.depth, verbose=FALSE)The output of ExoDataSubsampling is a list of ExoData objects, therefore its output can be used with any of the plotting functions to asses the quality of the samples. For example, using we may use paramDistBoxplot to get the following figures:
    p1 = paramDistBoxplot(exoList,which.param = "beta1")
    p2 = paramDistBoxplot(exoList,which.param = "beta2")
    gridExtra::grid.arrange(p1,p2,nrow = 1)Clearly there are increasing trends in both plots, and since we are only using the reads in chromosome 1, we are observing fewer reads than in a typical ChIP-exo/nexus experiment. In a higher quality experiment it is expected to show lower \(\hat{\beta}_1\) and \(\hat{\beta}_2\) levels. Additionally, the rate at which the estimated \(\hat{\beta}_2\) parameter increases is going to be higher in a lower quality experiment.
We presented a systematic exploration of a ChIP-exo experiment and show how to use the QC pipeline provided in ChIPexoQual. ChIPexoQual takes aligned reads as input and automatically generates several diagnostic plots and summary measures that enable assessing enrichment and library complexity. The implications of the diagnostic plots and the summary measures align well with more elaborate analysis that is computationally more expensive to perform and/or requires additional imputes that often may not be available.
sessionInfo("ChIPexoQual")## R version 4.3.1 (2023-06-16)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 22.04.3 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.18-bioc/R/lib/libRblas.so 
## LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.10.0
## 
## locale:
##  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
##  [3] LC_TIME=en_GB              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       
## 
## time zone: America/New_York
## tzcode source: system (glibc)
## 
## attached base packages:
## character(0)
## 
## other attached packages:
## [1] ChIPexoQual_1.26.0
## 
## loaded via a namespace (and not attached):
##   [1] RColorBrewer_1.1-3          rstudioapi_0.15.0          
##   [3] jsonlite_1.8.7              magrittr_2.0.3             
##   [5] magick_2.8.1                GenomicFeatures_1.54.0     
##   [7] farver_2.1.1                rmarkdown_2.25             
##   [9] BiocIO_1.12.0               zlibbioc_1.48.0            
##  [11] vctrs_0.6.4                 memoise_2.0.1              
##  [13] Rsamtools_2.18.0            RCurl_1.98-1.12            
##  [15] base64enc_0.1-3             htmltools_0.5.6.1          
##  [17] S4Arrays_1.2.0              progress_1.2.2             
##  [19] curl_5.1.0                  broom_1.0.5                
##  [21] SparseArray_1.2.0           Formula_1.2-5              
##  [23] sass_0.4.7                  bslib_0.5.1                
##  [25] htmlwidgets_1.6.2           cachem_1.0.8               
##  [27] GenomicAlignments_1.38.0    lifecycle_1.0.3            
##  [29] pkgconfig_2.0.3             Matrix_1.6-1.1             
##  [31] R6_2.5.1                    fastmap_1.1.1              
##  [33] GenomeInfoDbData_1.2.11     MatrixGenerics_1.14.0      
##  [35] digest_0.6.33               colorspace_2.1-0           
##  [37] AnnotationDbi_1.64.0        S4Vectors_0.40.0           
##  [39] Hmisc_5.1-1                 GenomicRanges_1.54.0       
##  [41] RSQLite_2.3.1               labeling_0.4.3             
##  [43] filelock_1.0.2              fansi_1.0.5                
##  [45] httr_1.4.7                  abind_1.4-5                
##  [47] compiler_4.3.1              withr_2.5.1                
##  [49] bit64_4.0.5                 htmlTable_2.4.1            
##  [51] backports_1.4.1             BiocParallel_1.36.0        
##  [53] viridis_0.6.4               DBI_1.1.3                  
##  [55] hexbin_1.28.3               biomaRt_2.58.0             
##  [57] base_4.3.1                  rappdirs_0.3.3             
##  [59] stats_4.3.1                 DelayedArray_0.28.0        
##  [61] rjson_0.2.21                tools_4.3.1                
##  [63] foreign_0.8-85              ChIPexoQualExample_1.25.0  
##  [65] nnet_7.3-19                 glue_1.6.2                 
##  [67] graphics_4.3.1              restfulr_0.0.15            
##  [69] grid_4.3.1                  checkmate_2.2.0            
##  [71] cluster_2.1.4               generics_0.1.3             
##  [73] gtable_0.3.4                BSgenome_1.70.0            
##  [75] tidyr_1.3.0                 ensembldb_2.26.0           
##  [77] data.table_1.14.8           hms_1.1.3                  
##  [79] xml2_1.3.5                  utf8_1.2.4                 
##  [81] XVector_0.42.0              BiocGenerics_0.48.0        
##  [83] pillar_1.9.0                stringr_1.5.0              
##  [85] dplyr_1.1.3                 BiocFileCache_2.10.0       
##  [87] lattice_0.22-5              rtracklayer_1.62.0         
##  [89] bit_4.0.5                   biovizBase_1.50.0          
##  [91] tidyselect_1.2.0            Biostrings_2.70.0          
##  [93] knitr_1.44                  gridExtra_2.3              
##  [95] bookdown_0.36               IRanges_2.36.0             
##  [97] ProtGenerics_1.34.0         SummarizedExperiment_1.32.0
##  [99] stats4_4.3.1                xfun_0.40                  
## [101] datasets_4.3.1              Biobase_2.62.0             
## [103] matrixStats_1.0.0           stringi_1.7.12             
## [105] lazyeval_0.2.2              yaml_2.3.7                 
## [107] evaluate_0.22               codetools_0.2-19           
## [109] tibble_3.2.1                BiocManager_1.30.22        
## [111] cli_3.6.1                   rpart_4.1.21               
## [113] munsell_0.5.0               jquerylib_0.1.4            
## [115] Rcpp_1.0.11                 dichromat_2.0-0.1          
## [117] GenomeInfoDb_1.38.0         dbplyr_2.3.4               
## [119] utils_4.3.1                 png_0.1-8                  
## [121] XML_3.99-0.14               parallel_4.3.1             
## [123] ggplot2_3.4.4               blob_1.2.4                 
## [125] methods_4.3.1               prettyunits_1.2.0          
## [127] AnnotationFilter_1.26.0     bitops_1.0-7               
## [129] viridisLite_0.4.2           VariantAnnotation_1.48.0   
## [131] scales_1.2.1                grDevices_4.3.1            
## [133] purrr_1.0.2                 crayon_1.5.2               
## [135] BiocStyle_2.30.0            rlang_1.1.1                
## [137] KEGGREST_1.42.0Serandour, Aurelien, Brown Gordon, Joshua Cohen, and Jason Carroll. 2013. “Development of and Illumina-Based ChIP-Exonuclease Method Provides Insight into FoxA1-DNA Binding Properties.” Genome Biology.
Welch, Rene, Dongjun Chung, Jeffrey Grass, Robert Landick, and Sündüz Keleş. 2016. “Data Exploration, Quality Control, and Statistical Analysis of ChIP-Exo/Nexus Experiments.” Submitted.