Introduction
Installation
Input files
Usage
4.1 Report
4.2 Functions
Though a small chemical change in the genome, DNA methylation has significant impact in several diseases, developmental processes and other biological changes. Hence methylation data should be analyzed carefully to gain biological insights. scmeth package offers a few functions to assess the quality of the methylation data.
This bioconductor package contains functions to perform quality control and preprocessing analysis for single-cell methylation data. scmeth is especially customized to be used with the output from the FireCloud implementation of methylation pipeline. In addition to individual functions, report function in the package provides all inclusive report using most of the functions. If users prefer they can just use the report function to gain summary of their data.
scmeth is available in bioconductor and can be downloaded using the following commands
if (!requireNamespace("BiocManager", quietly=TRUE))
    install.packages("BiocManager")
BiocManager::install("scmeth")Load the package
Main input for most of the function is a bsseq object. In the FireCloud implementation it is stored as hdf5 file which can be read via loadHDF5SummarizedExperiment function in HDF5Array package. Code chunk below shows how it can be loaded.
A comprehensive quality control report can be generated in the package via report function. report function takes the bs object, the directory where the report should be saved, organism that this data is obtained from and the genomic build. Following is an example usage of the report function.
report function also takes two optional arguments: subSample and offset. With subsample parameter users can choose how many CpGs to consider in the analysis out of all the CpG information available. Our analysis have shown that conducting analysis with one million CpGs is suffice to capture the quality of the samples. However when more CpGs are added they reflect the full data precisely. Offset parameter is to avoid any telomere region when subsetting from the beginning of the data. Hence Offset parameter would avoid first n number of CpGs.
Command above generated an html report named qcReport.html. It will be stored in the indicated directory.
This section will elaborate on some of the main functions and show the usage of these functions based on a sample data set that comes along with the package.
scmeth package contains several functions to assess different metrics and success of the sequencing process.
One main metric is the CpG coverage. Coverage of the CpG can be assessed in different ways. Very basic one is to check how many CpG were observed in each sample. coverage function can be used to get this information.
Loading the data
directory <- system.file("extdata", "bismark_data", package='scmeth')
bsObject <- HDF5Array::loadHDF5SummarizedExperiment(directory)## 2017-08-02_HL2F5BBXX_2_AAGAGGCA_AGAAGG_report.txt 
##                                               756 
## 2017-08-02_HL2F5BBXX_2_AAGAGGCA_AGGATG_report.txt 
##                                               424 
## 2017-08-02_HL2F5BBXX_2_AAGAGGCA_ATCAAG_report.txt 
##                                               333Read information is important to assess whether sequencing and alignment succeeded. readmetrics function outputs a visualization showing number of reads seen in each samples and of those reads what proportion of them were mapped to the reference genome.
##                                              sample   total mapped unmapped
## 1 2017-08-02_HL2F5BBXX_2_AAGAGGCA_AGAAGG_report.txt 1145278 974438   170840
## 2 2017-08-02_HL2F5BBXX_2_AAGAGGCA_AGGATG_report.txt  763055 633756   129299
## 3 2017-08-02_HL2F5BBXX_2_AAGAGGCA_ATCAAG_report.txt  847927 717059   130868CpG Islands are characterized by their high GC content, high level of observed to expected ratio of CpGs and length over 500 bp. However some repeat regions in the genome also fit the same criteria although they are not bona fide CpG Island. Therefore it is important to see how many CpGs are observed in the non repeat regions of the genome. repMask functions provide information on the CpG coverage in non repeat regions of the genome. In order to build the repeat mask regions of the genome repmask function will require the organism and the genome build information.
library(BSgenome.Mmusculus.UCSC.mm10)
load(system.file("extdata", 'bsObject.rda', package='scmeth'))
repMask(bs, Mmusculus, "mm10")##                     coveredCpgs
## sc-RRBS_zyg_01_chr1       12208
## sc-RRBS_zyg_02_chr1        3056
## sc-RRBS_zyg_03_chr1        6666
There are several other ways the number of CpGs captured can be visualized. One of the way is to observe how the CpGs are distributed across different chromosomes. *chromosomeCoverage outputs CpG coverage by individual chromosomes.(Since the example data only contains information in chromosome 1 only the CpGs covered in chromosome 1 is shown.)
##   2017-08-02_HL2F5BBXX_2_AAGAGGCA_AGAAGG_report.txt
## 1                                               756
##   2017-08-02_HL2F5BBXX_2_AAGAGGCA_AGGATG_report.txt
## 1                                               424
##   2017-08-02_HL2F5BBXX_2_AAGAGGCA_ATCAAG_report.txt
## 1                                               333Another way to observe the distribution of CpGs is to classify them by the genomic features they belong. Some of the features are very specific to the CpG dense regions such as CpG Islands, CpG Shores, CpG Shelves etc. Others are general genomic features such as introns, exons, promoters etc. This information can be obtained by featureCoverage function. In addition to the bs object this function requires the genomic features of interest and the genome build. Each element in the table represents the fraction of CpGs seen in particular cell in specific region compared to all the CpGs seen in that region.
CpGs are not distributed across the genome uniformly. Most of the genome contains very low percentage of CpGs except for the CpG dense regions, i.e. CpG islands. Bisulfite sequencing targets all the CpGs across the genome, however reduced representation bisulfite sequencing (RRBS) target CpG dense CpG islands. Therefore CpG density plot will be a great diagnostic to see whether the protocol succeeded. In order to calculate the CpG density a window length should be specified. By default cpgDensity function chooses 1kB regions. Therefore CpG density plot can be used to check whether the protocol specifically targeted CpG dense or CpG sparse regions or whether CpGs were obtained uniformly across the regions.
In addition to the CpG coverage, methylation data can be assessed via down sampling analysis, methylation bias plot and methylation distribution. Down sampling analysis is a technique to assess whether the sequencing process achieved the saturation level in terms of CpG capture. In order to perform down sampling analysis CpGs that are covered at least will be sampled via binomial random sampling with given probability. At each probability level the number of CpGs captured is assessed. If the number of CpG captured attains a plateau then the sequencing was successful. downsample function provides a matrix of CpG coverage for each sample at various down sampling rates. The report renders this information into a plot. Downsampling rate ranges from 0.01 to 1, however users can change the downsampling rates.
Methylation bias plot shows the methylation along the reads. In a high quality samples methylation across the read would be more or less a horizontal line. However there could be fluctuations in the beginning or the end of the read due to the quality of the bases. Single cell sequencing samples also can show jagged trend in the methylation bias plot due to low read count. Methylation bias can be assessed via mbiasPlot function. This function takes the mbias file generated from FireCloud pipeline and generates the methylation bias plot.
methylationBiasFile <- '2017-04-21_HG23KBCXY_2_AGGCAGAA_TATCTC_pe.M-bias.txt'
mbiasList <- mbiasplot(mbiasFiles=system.file("extdata", methylationBiasFile,
                                         package='scmeth'))
mbiasDf <- do.call(rbind.data.frame, mbiasList)
meanTable <- stats::aggregate(methylation ~ position + read, data=mbiasDf, FUN=mean)
sdTable <- stats::aggregate(methylation ~ position + read, data=mbiasDf, FUN=sd)
seTable <- stats::aggregate(methylation ~ position + read, data=mbiasDf, FUN=function(x){sd(x)/sqrt(length(x))})
sum_mt<-data.frame('position'=meanTable$position,'read'=meanTable$read,
                       'meth'=meanTable$methylation, 'sdMeth'=sdTable$methylation,
                       'seMeth'=seTable$methylation)
sum_mt$upperCI <- sum_mt$meth + (1.96*sum_mt$seMeth)
sum_mt$lowerCI <- sum_mt$meth - (1.96*sum_mt$seMeth)
sum_mt$read_rep <- paste(sum_mt$read, sum_mt$position, sep="_")
g <- ggplot2::ggplot(sum_mt)
g <- g + ggplot2::geom_line(ggplot2::aes_string(x='position', y='meth',
                                                colour='read'))
g <- g + ggplot2::geom_ribbon(ggplot2::aes_string(ymin = 'lowerCI',
                        ymax = 'upperCI', x='position', fill = 'read'),
                        alpha=0.4)
g <- g + ggplot2::ylim(0,100) + ggplot2::ggtitle('Mbias Plot')
g <- g + ggplot2::ylab('methylation')
gmethylationDist function provides the methylation distribution of the samples. In this visualization methylation is divided into quantiles and ordered according to the cells with the lowest methylation to highest methylation. In single cell analysis almost all CpGs will be in the highest quantile or the lowest quantile. This visualization provides information on whether there are cells with intermediate methylation. Ideally , in single cell methylation most methylation should be either 1 or 0. If there are large number of intermediate methylation this indicates there might be some error in sequencing.
## 2017-08-02_HL2F5BBXX_2_AAGAGGCA_AGAAGG_report.txt 
##                                         0.7841647 
## 2017-08-02_HL2F5BBXX_2_AAGAGGCA_AGGATG_report.txt 
##                                         0.6940448 
## 2017-08-02_HL2F5BBXX_2_AAGAGGCA_ATCAAG_report.txt 
##                                         0.8130466Another important metric in methylation analysis is the bisulfite conversion rate. Bisulfite conversion rate indicates out of all the Cytosines in the non CpG context what fraction of them were methylated. Ideally this number should be 1 or 100% indicating none of the non CpG context cytosines are methylated. However in real data this will not be the case, yet bisulfite conversion rate below 95% indicates some problem with sample preparation. bsConversionPlot function generates a plot showing this metric for each sample.
##                                              sample       bsc
## 1 2017-08-02_HL2F5BBXX_2_AAGAGGCA_AGAAGG_report.txt 0.9940704
## 2 2017-08-02_HL2F5BBXX_2_AAGAGGCA_AGGATG_report.txt 0.9951570
## 3 2017-08-02_HL2F5BBXX_2_AAGAGGCA_ATCAAG_report.txt 0.9932266## R version 4.1.1 (2021-08-10)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 20.04.3 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.14-bioc/R/lib/libRblas.so
## LAPACK: /home/biocbuild/bbs-3.14-bioc/R/lib/libRlapack.so
## 
## 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       
## 
## attached base packages:
## [1] stats4    stats     graphics  grDevices utils     datasets  methods  
## [8] base     
## 
## other attached packages:
##  [1] BSgenome.Hsapiens.NCBI.GRCh38_1.3.1000
##  [2] BSgenome.Mmusculus.UCSC.mm10_1.4.3    
##  [3] BSgenome_1.62.0                       
##  [4] rtracklayer_1.54.0                    
##  [5] Biostrings_2.62.0                     
##  [6] XVector_0.34.0                        
##  [7] GenomicRanges_1.46.0                  
##  [8] GenomeInfoDb_1.30.0                   
##  [9] IRanges_2.28.0                        
## [10] S4Vectors_0.32.0                      
## [11] BiocGenerics_0.40.0                   
## [12] scmeth_1.14.0                         
## 
## loaded via a namespace (and not attached):
##   [1] colorspace_2.0-2              bsseq_1.30.0                 
##   [3] rjson_0.2.20                  ellipsis_0.3.2               
##   [5] farver_2.1.0                  DT_0.19                      
##   [7] bit64_4.0.5                   interactiveDisplayBase_1.32.0
##   [9] AnnotationDbi_1.56.0          fansi_0.5.0                  
##  [11] xml2_1.3.2                    R.methodsS3_1.8.1            
##  [13] sparseMatrixStats_1.6.0       cachem_1.0.6                 
##  [15] knitr_1.36                    jsonlite_1.7.2               
##  [17] Rsamtools_2.10.0              dbplyr_2.1.1                 
##  [19] R.oo_1.24.0                   png_0.1-7                    
##  [21] shiny_1.7.1                   HDF5Array_1.22.0             
##  [23] BiocManager_1.30.16           readr_2.0.2                  
##  [25] compiler_4.1.1                httr_1.4.2                   
##  [27] assertthat_0.2.1              Matrix_1.3-4                 
##  [29] fastmap_1.1.0                 limma_3.50.0                 
##  [31] later_1.3.0                   htmltools_0.5.2              
##  [33] prettyunits_1.1.1             tools_4.1.1                  
##  [35] gtable_0.3.0                  glue_1.4.2                   
##  [37] GenomeInfoDbData_1.2.7        annotatr_1.20.0              
##  [39] reshape2_1.4.4                dplyr_1.0.7                  
##  [41] rappdirs_0.3.3                Rcpp_1.0.7                   
##  [43] Biobase_2.54.0                jquerylib_0.1.4              
##  [45] vctrs_0.3.8                   rhdf5filters_1.6.0           
##  [47] crosstalk_1.1.1               DelayedMatrixStats_1.16.0    
##  [49] xfun_0.27                     stringr_1.4.0                
##  [51] mime_0.12                     lifecycle_1.0.1              
##  [53] restfulr_0.0.13               gtools_3.9.2                 
##  [55] XML_3.99-0.8                  AnnotationHub_3.2.0          
##  [57] zlibbioc_1.40.0               scales_1.1.1                 
##  [59] vroom_1.5.5                   hms_1.1.1                    
##  [61] promises_1.2.0.1              MatrixGenerics_1.6.0         
##  [63] parallel_4.1.1                SummarizedExperiment_1.24.0  
##  [65] rhdf5_2.38.0                  yaml_2.2.1                   
##  [67] curl_4.3.2                    memoise_2.0.0                
##  [69] ggplot2_3.3.5                 sass_0.4.0                   
##  [71] biomaRt_2.50.0                stringi_1.7.5                
##  [73] RSQLite_2.2.8                 highr_0.9                    
##  [75] BiocVersion_3.14.0            BiocIO_1.4.0                 
##  [77] permute_0.9-5                 GenomicFeatures_1.46.0       
##  [79] filelock_1.0.2                BiocParallel_1.28.0          
##  [81] rlang_0.4.12                  pkgconfig_2.0.3              
##  [83] matrixStats_0.61.0            bitops_1.0-7                 
##  [85] evaluate_0.14                 lattice_0.20-45              
##  [87] purrr_0.3.4                   Rhdf5lib_1.16.0              
##  [89] labeling_0.4.2                GenomicAlignments_1.30.0     
##  [91] htmlwidgets_1.5.4             bit_4.0.4                    
##  [93] tidyselect_1.1.1              plyr_1.8.6                   
##  [95] magrittr_2.0.1                R6_2.5.1                     
##  [97] generics_0.1.1                DelayedArray_0.20.0          
##  [99] DBI_1.1.1                     withr_2.4.2                  
## [101] pillar_1.6.4                  KEGGREST_1.34.0              
## [103] RCurl_1.98-1.5                tibble_3.1.5                 
## [105] crayon_1.4.1                  utf8_1.2.2                   
## [107] BiocFileCache_2.2.0           tzdb_0.1.2                   
## [109] rmarkdown_2.11                progress_1.2.2               
## [111] locfit_1.5-9.4                grid_4.1.1                   
## [113] data.table_1.14.2             blob_1.2.2                   
## [115] digest_0.6.28                 xtable_1.8-4                 
## [117] httpuv_1.6.3                  regioneR_1.26.0              
## [119] R.utils_2.11.0                munsell_0.5.0                
## [121] bslib_0.3.1