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_4_CTCTCTAC_AGAAGG_report.txt 
##                                              4070 
## 2017-08-02_HL2F5BBXX_4_CGAGGCTG_TGTAGG_report.txt 
##                                               852 
## 2017-08-02_HL2F5BBXX_6_CGAGGCTG_AGGATG_report.txt 
##                                               422Read 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
## 1 2017-08-02_HL2F5BBXX_4_CTCTCTAC_AGAAGG_report.txt 1871315 1595883
## 2 2017-08-02_HL2F5BBXX_4_CGAGGCTG_TGTAGG_report.txt  554368  458930
## 3 2017-08-02_HL2F5BBXX_6_CGAGGCTG_AGGATG_report.txt  454427  360456
##   unmapped
## 1   275432
## 2    95438
## 3    93971CpG 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_4_CTCTCTAC_AGAAGG_report.txt
## 1                                              4070
##   2017-08-02_HL2F5BBXX_4_CGAGGCTG_TGTAGG_report.txt
## 1                                               852
##   2017-08-02_HL2F5BBXX_6_CGAGGCTG_AGGATG_report.txt
## 1                                               422Another 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_4_CTCTCTAC_AGAAGG_report.txt 
##                                         0.2923675 
## 2017-08-02_HL2F5BBXX_4_CGAGGCTG_TGTAGG_report.txt 
##                                         0.7517606 
## 2017-08-02_HL2F5BBXX_6_CGAGGCTG_AGGATG_report.txt 
##                                         0.6413902Another 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_4_CTCTCTAC_AGAAGG_report.txt 0.9950714
## 2 2017-08-02_HL2F5BBXX_4_CGAGGCTG_TGTAGG_report.txt 0.9916822
## 3 2017-08-02_HL2F5BBXX_6_CGAGGCTG_AGGATG_report.txt 0.9945638## R version 3.5.2 (2018-12-20)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 16.04.5 LTS
## 
## Matrix products: default
## BLAS: /home/biocbuild/bbs-3.8-bioc/R/lib/libRblas.so
## LAPACK: /home/biocbuild/bbs-3.8-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] parallel  stats4    stats     graphics  grDevices utils     datasets 
## [8] methods   base     
## 
## other attached packages:
##  [1] BSgenome.Hsapiens.NCBI.GRCh38_1.3.1000
##  [2] BSgenome.Mmusculus.UCSC.mm10_1.4.0    
##  [3] BSgenome_1.50.0                       
##  [4] rtracklayer_1.42.1                    
##  [5] Biostrings_2.50.2                     
##  [6] XVector_0.22.0                        
##  [7] SummarizedExperiment_1.12.0           
##  [8] DelayedArray_0.8.0                    
##  [9] BiocParallel_1.16.5                   
## [10] matrixStats_0.54.0                    
## [11] Biobase_2.42.0                        
## [12] GenomicRanges_1.34.0                  
## [13] GenomeInfoDb_1.18.1                   
## [14] IRanges_2.16.0                        
## [15] S4Vectors_0.20.1                      
## [16] BiocGenerics_0.28.0                   
## [17] scmeth_1.2.2                          
## 
## loaded via a namespace (and not attached):
##  [1] bitops_1.0-6                  bit64_0.9-7                  
##  [3] bsseq_1.18.0                  progress_1.2.0               
##  [5] httr_1.4.0                    tools_3.5.2                  
##  [7] R6_2.3.0                      DT_0.5                       
##  [9] HDF5Array_1.10.1              DBI_1.0.0                    
## [11] lazyeval_0.2.1                colorspace_1.3-2             
## [13] permute_0.9-4                 tidyselect_0.2.5             
## [15] prettyunits_1.0.2             curl_3.2                     
## [17] bit_1.1-14                    compiler_3.5.2               
## [19] labeling_0.3                  scales_1.0.0                 
## [21] readr_1.3.1                   stringr_1.3.1                
## [23] digest_0.6.18                 Rsamtools_1.34.0             
## [25] R.utils_2.7.0                 rmarkdown_1.11               
## [27] pkgconfig_2.0.2               htmltools_0.3.6              
## [29] limma_3.38.3                  regioneR_1.14.0              
## [31] htmlwidgets_1.3               rlang_0.3.0.1                
## [33] RSQLite_2.1.1                 shiny_1.2.0                  
## [35] DelayedMatrixStats_1.4.0      bindr_0.1.1                  
## [37] jsonlite_1.6                  crosstalk_1.0.0              
## [39] gtools_3.8.1                  R.oo_1.22.0                  
## [41] dplyr_0.7.8                   RCurl_1.95-4.11              
## [43] magrittr_1.5                  GenomeInfoDbData_1.2.0       
## [45] Matrix_1.2-15                 Rcpp_1.0.0                   
## [47] munsell_0.5.0                 Rhdf5lib_1.4.2               
## [49] R.methodsS3_1.7.1             stringi_1.2.4                
## [51] yaml_2.2.0                    zlibbioc_1.28.0              
## [53] rhdf5_2.26.2                  plyr_1.8.4                   
## [55] AnnotationHub_2.14.2          grid_3.5.2                   
## [57] blob_1.1.1                    promises_1.0.1               
## [59] crayon_1.3.4                  lattice_0.20-38              
## [61] GenomicFeatures_1.34.1        hms_0.4.2                    
## [63] locfit_1.5-9.1                knitr_1.21                   
## [65] pillar_1.3.1                  reshape2_1.4.3               
## [67] biomaRt_2.38.0                XML_3.98-1.16                
## [69] glue_1.3.0                    evaluate_0.12                
## [71] annotatr_1.8.0                data.table_1.11.8            
## [73] BiocManager_1.30.4            httpuv_1.4.5.1               
## [75] gtable_0.2.0                  purrr_0.2.5                  
## [77] assertthat_0.2.0              ggplot2_3.1.0                
## [79] xfun_0.4                      mime_0.6                     
## [81] xtable_1.8-3                  later_0.7.5                  
## [83] tibble_2.0.0                  GenomicAlignments_1.18.1     
## [85] AnnotationDbi_1.44.0          memoise_1.1.0                
## [87] bindrcpp_0.2.2                interactiveDisplayBase_1.20.0