Instructions on using the DMCFB package.
DMCFB 1.6.0
The DMCFB package is a pipeline to identify differentially methylated
cytosine (DMC) in bisulfite sequencing data using Bayesian functional
regression models.
In what follows we provides some guidelines on how to read your data and analyze
them.
The R-method readBismark() is used to read bisulfite data files that are
created by Bismark. Each file must include six columns, with no header, that
represent
and each row is a cytosine (or a small region) in DNA.
The function readBismark(<files' paths>, <files' names>) has two inputs:
‘the paths of the files’ and ‘the names of the files’.
Using this function an object of class BSDMC is created.
Extra information about data such as Age, Gender, Group, etc, must be assigned
to the object using DataFrame function.
As an example, we have provided three files in the package that can be read as
follows:
library(DMCFB)
#> Loading required package: SummarizedExperiment
#> Loading required package: MatrixGenerics
#> Loading required package: matrixStats
#> 
#> Attaching package: 'MatrixGenerics'
#> The following objects are masked from 'package:matrixStats':
#> 
#>     colAlls, colAnyNAs, colAnys, colAvgsPerRowSet, colCollapse,
#>     colCounts, colCummaxs, colCummins, colCumprods, colCumsums,
#>     colDiffs, colIQRDiffs, colIQRs, colLogSumExps, colMadDiffs,
#>     colMads, colMaxs, colMeans2, colMedians, colMins, colOrderStats,
#>     colProds, colQuantiles, colRanges, colRanks, colSdDiffs, colSds,
#>     colSums2, colTabulates, colVarDiffs, colVars, colWeightedMads,
#>     colWeightedMeans, colWeightedMedians, colWeightedSds,
#>     colWeightedVars, rowAlls, rowAnyNAs, rowAnys, rowAvgsPerColSet,
#>     rowCollapse, rowCounts, rowCummaxs, rowCummins, rowCumprods,
#>     rowCumsums, rowDiffs, rowIQRDiffs, rowIQRs, rowLogSumExps,
#>     rowMadDiffs, rowMads, rowMaxs, rowMeans2, rowMedians, rowMins,
#>     rowOrderStats, rowProds, rowQuantiles, rowRanges, rowRanks,
#>     rowSdDiffs, rowSds, rowSums2, rowTabulates, rowVarDiffs, rowVars,
#>     rowWeightedMads, rowWeightedMeans, rowWeightedMedians,
#>     rowWeightedSds, rowWeightedVars
#> Loading required package: GenomicRanges
#> Loading required package: stats4
#> Loading required package: BiocGenerics
#> Loading required package: parallel
#> 
#> Attaching package: 'BiocGenerics'
#> The following objects are masked from 'package:parallel':
#> 
#>     clusterApply, clusterApplyLB, clusterCall, clusterEvalQ,
#>     clusterExport, clusterMap, parApply, parCapply, parLapply,
#>     parLapplyLB, parRapply, parSapply, parSapplyLB
#> The following objects are masked from 'package:stats':
#> 
#>     IQR, mad, sd, var, xtabs
#> The following objects are masked from 'package:base':
#> 
#>     Filter, Find, Map, Position, Reduce, anyDuplicated, append,
#>     as.data.frame, basename, cbind, colnames, dirname, do.call,
#>     duplicated, eval, evalq, get, grep, grepl, intersect, is.unsorted,
#>     lapply, mapply, match, mget, order, paste, pmax, pmax.int, pmin,
#>     pmin.int, rank, rbind, rownames, sapply, setdiff, sort, table,
#>     tapply, union, unique, unsplit, which.max, which.min
#> Loading required package: S4Vectors
#> 
#> Attaching package: 'S4Vectors'
#> The following objects are masked from 'package:base':
#> 
#>     I, expand.grid, unname
#> Loading required package: IRanges
#> Loading required package: GenomeInfoDb
#> Loading required package: Biobase
#> Welcome to Bioconductor
#> 
#>     Vignettes contain introductory material; view with
#>     'browseVignettes()'. To cite Bioconductor, see
#>     'citation("Biobase")', and for packages 'citation("pkgname")'.
#> 
#> Attaching package: 'Biobase'
#> The following object is masked from 'package:MatrixGenerics':
#> 
#>     rowMedians
#> The following objects are masked from 'package:matrixStats':
#> 
#>     anyMissing, rowMedians
#> Loading required package: BiocParallel
#> DMCFB package, Version 1.6.0, Released 2021-05-19
#> DMCFB is a pipeline for identifying differentially methylated 
#>     cytosines using a Bayesian functional regression model in bisulfite
#>     sequencing data. By using a functional regression data model, it tries to
#>     capture position-specific, group-specific and other covariates-specific
#>     methylation patterns as well as spatial correlation patterns and unknown
#>     underlying models of methylation data. It is robust and flexible with
#>     respect to the true underlying models and inclusion of any covariates, and
#>     the missing values are imputed using spatial correlation between positions
#>     and samples. A Bayesian approach is adopted for estimation and inference in
#>     the proposed method.
#> BugReports: https://github.com/shokoohi/DMCFB/issues
#> 
#> Attaching package: 'DMCFB'
#> The following object is masked from 'package:Biobase':
#> 
#>     combine
#> The following object is masked from 'package:BiocGenerics':
#> 
#>     combine
fn <- list.files(system.file("extdata",package = "DMCFB"))
fn.f <- list.files(system.file("extdata",package="DMCFB"), full.names=TRUE)
OBJ <- readBismark(fn.f, fn, mc.cores = 2)
#> 
  |                                                                            
  |                                                                      |   0%
  |                                                                            
  |===================================                                   |  50%
#> 
#> Processing sample blk.BCU1568_BC_BS_1 ... 
#> Read 23710 records
#> 
  |                                                                            
  |======================================================================| 100%
#> 
#> Processing sample blk.BCU173_TC_BS_1 ... 
#> Read 24421 records
#> 
#> Processing sample blk.BCU551_Mono_BS_1 ... 
#> Read 23541 records
#> 
#> Building BSDMC object.
cdOBJ <- DataFrame(Cell = factor(c("BC", "TC","Mono"),
levels = c("BC", "TC", "Mono")), row.names = c("BCU1568","BCU173","BCU551"))
colData(OBJ) <- cdOBJ
OBJ
#> class: BSDMC 
#> dim: 25668 3 
#> metadata(0):
#> assays(3): methReads totalReads methLevels
#> rownames(25668): 1 2 ... 25667 25668
#> rowData names(0):
#> colnames(3): BCU1568 BCU173 BCU551
#> colData names(1): CellAlternatively, one can use two integer matrices and a DataFrame to create
BSDMC object using cBSDMC() function. One matrix includes the read-depth and
the other one includes methylation reads. The columns of these matrices
represent samples and the rows represent cytosine positions.
Additional information about the genomic positions and covariates must be stored
in a DataFrame and then assign to the object.
The following exampel shows the details.
library(DMCFB)
set.seed(1980)
nr <- 1000
nc <- 8
metht <- matrix(as.integer(runif(nr * nc, 0, 100)), nr)
methc <- matrix(rbinom(n=nr*nc,c(metht),prob = runif(nr*nc)),nr,nc)
methl <- methc/metht
r1 <- GRanges(rep('chr1', nr), IRanges(1:nr, width=1), strand='*')
names(r1) <- 1:nr
cd1 <- DataFrame(Group=rep(c('G1','G2'),each=nc/2),row.names=LETTERS[1:nc])
OBJ2 <- cBSDMC(rowRanges=r1,methReads=methc,totalReads=metht,
  methLevels=methl,colData=cd1)
OBJ2
#> class: BSDMC 
#> dim: 1000 8 
#> metadata(0):
#> assays(3): methReads totalReads methLevels
#> rownames(1000): 1 2 ... 999 1000
#> rowData names(0):
#> colnames(8): A B ... G H
#> colData names(1): GroupTo identify DMCs, one need to use the function findDMCFB() function.
The function
library(DMCFB)
start.time <- Sys.time()
path0 <- "..//BCData/" # provide the path to the files
namelist.new <- list.files(path0,pattern="blk",full.names=F)
namelist.new.f <- list.files(path0,pattern="blk",full.names=T)
type <- NULL
for(i in seq_along(namelist.new)){
    type[i] <- unlist(strsplit(namelist.new[i], split=c('_'), fixed=TRUE))[2]
}
type
table(type)
indTC <- which(type=="TC")
indBC <- which(type=="BC")
indMono <- which(type=="Mono")
namelist.new <- namelist.new[c(indBC,indMono,indTC)]
namelist.new.f <- namelist.new.f[c(indBC,indMono,indTC)]
BLKDat <- readBismark(namelist.new.f, namelist.new, mc.cores = 2)
colData1 <- DataFrame(Group = factor(
  c(rep("BC",length(indBC)), rep("Mono",length(indMono)), 
  rep("TC", length(indTC))), levels = c("BC", "Mono", "TC")), 
  row.names = colnames(BLKData))
colData(BLKDat) <- colData1
BLK.BC.Mono.TC <- sort(BLKDat)
DMC.obj = findDMCFB(object = BLKDat, bwa = 30, bwb = 30, nBurn = 300, nMC = 300,
  nThin = 1, alpha = 5e-5, pSize = 500, sfiles = FALSE)To plot DMCs one can use the plotDMCFB() function to plot an BSDMC object
that resulted from running findDMCFB() function.
To illustrate use the following example:
library(DMCFB)
set.seed(1980)
nr <- 1000
nc <- 8
metht <- matrix(as.integer(runif(nr * nc, 0, 100)), nr)
methc <- matrix(rbinom(n=nr*nc,c(metht),prob = runif(nr*nc)),nr,nc)
methl <- methc/metht
r1 <- GRanges(rep('chr1', nr), IRanges(1:nr, width=1), strand='*')
names(r1) <- 1:nr
cd1 <- DataFrame(Group=rep(c('G1','G2'),each=nc/2),row.names=LETTERS[1:nc])
OBJ1 <- cBSDMC(rowRanges=r1,methReads=methc,totalReads=metht,
  methLevels=methl,colData=cd1)
OBJ2 = findDMCFB(object = OBJ1, bwa = 30, bwb = 30, nBurn = 10, nMC = 10,
  nThin = 1, alpha = 0.05, pSize = 500, sfiles = FALSE)
#> ------------------------------------------------------------
#> Running Bayesian functional regression model ...
#> The priors's SD = 0.3027, estimated from data ...
#> Number of assigned cores: 4 ...
#> ------------------------------------------------------------
#> Fitted model:
#> logit(MethRead/ReadDepth) ~ F(Group)
#> ------------------------------------------------------------
#> Creating 1 batches of genomic positions ...
#> Running batch 1/1; chr1; 1000 positions; Region [   1, 1000]; Date 2021-05-19 17:32:40
#> ------------------------------------------------------------
#> Combining 1 objects ...
#> Objects are combined.
#> ------------------------------------------------------------
#> Identifying DMCs ...
#> DMCs are identified.
#> ------------------------------------------------------------
#> Percentage of non-DMCs and DMCs:
#> Equal(%)   DMC(%) 
#>     37.3     62.7
#> ------------------------------------------------------------
#> Percentage of hyper-, hypo-, and equal-methylated positions:
#>        Equal(%) Hyper(%) Hypo(%)
#> G2vsG1     37.3       31    31.7
#> ------------------------------------------------------------
plotDMCFB(OBJ2, region = c(1,400), nSplit = 2)sessionInfo()
#> R version 4.1.0 (2021-05-18)
#> Platform: x86_64-pc-linux-gnu (64-bit)
#> Running under: Ubuntu 20.04.2 LTS
#> 
#> Matrix products: default
#> BLAS:   /home/biocbuild/bbs-3.13-bioc/R/lib/libRblas.so
#> LAPACK: /home/biocbuild/bbs-3.13-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] parallel  stats4    stats     graphics  grDevices utils     datasets 
#> [8] methods   base     
#> 
#> other attached packages:
#>  [1] DMCFB_1.6.0                 BiocParallel_1.26.0        
#>  [3] SummarizedExperiment_1.22.0 Biobase_2.52.0             
#>  [5] GenomicRanges_1.44.0        GenomeInfoDb_1.28.0        
#>  [7] IRanges_2.26.0              S4Vectors_0.30.0           
#>  [9] BiocGenerics_0.38.0         MatrixGenerics_1.4.0       
#> [11] matrixStats_0.58.0          BiocStyle_2.20.0           
#> 
#> loaded via a namespace (and not attached):
#>   [1] minqa_1.2.4              colorspace_2.0-1         rjson_0.2.20            
#>   [4] ellipsis_0.3.2           benchmarkme_1.0.7        htmlTable_2.2.1         
#>   [7] XVector_0.32.0           base64enc_0.1-3          rstudioapi_0.13         
#>  [10] fansi_0.4.2              codetools_0.2-18         splines_4.1.0           
#>  [13] doParallel_1.0.16        knitr_1.33               Formula_1.2-4           
#>  [16] jsonlite_1.7.2           speedglm_0.3-3           nloptr_1.2.2.2          
#>  [19] Rsamtools_2.8.0          cluster_2.1.2            png_0.1-7               
#>  [22] BiocManager_1.30.15      compiler_4.1.0           httr_1.4.2              
#>  [25] backports_1.2.1          assertthat_0.2.1         Matrix_1.3-3            
#>  [28] htmltools_0.5.1.1        tools_4.1.0              coda_0.19-4             
#>  [31] gtable_0.3.0             glue_1.4.2               GenomeInfoDbData_1.2.6  
#>  [34] dplyr_1.0.6              Rcpp_1.0.6               jquerylib_0.1.4         
#>  [37] vctrs_0.3.8              Biostrings_2.60.0        nlme_3.1-152            
#>  [40] rtracklayer_1.52.0       iterators_1.0.13         xfun_0.23               
#>  [43] stringr_1.4.0            lme4_1.1-27              lifecycle_1.0.0         
#>  [46] restfulr_0.0.13          XML_3.99-0.6             zlibbioc_1.38.0         
#>  [49] MASS_7.3-54              scales_1.1.1             RColorBrewer_1.1-2      
#>  [52] yaml_2.2.1               gridExtra_2.3            ggplot2_3.3.3           
#>  [55] sass_0.4.0               rpart_4.1-15             latticeExtra_0.6-29     
#>  [58] stringi_1.6.2            highr_0.9                BiocIO_1.2.0            
#>  [61] fastDummies_1.6.3        foreach_1.5.1            checkmate_2.0.0         
#>  [64] boot_1.3-28              benchmarkmeData_1.0.4    rlang_0.4.11            
#>  [67] pkgconfig_2.0.3          bitops_1.0-7             arm_1.11-2              
#>  [70] evaluate_0.14            lattice_0.20-44          purrr_0.3.4             
#>  [73] GenomicAlignments_1.28.0 htmlwidgets_1.5.3        tidyselect_1.1.1        
#>  [76] magrittr_2.0.1           bookdown_0.22            R6_2.5.0                
#>  [79] magick_2.7.2             snow_0.4-3               generics_0.1.0          
#>  [82] Hmisc_4.5-0              DelayedArray_0.18.0      DBI_1.1.1               
#>  [85] pillar_1.6.1             foreign_0.8-81           survival_3.2-11         
#>  [88] abind_1.4-5              RCurl_1.98-1.3           nnet_7.3-16             
#>  [91] tibble_3.1.2             crayon_1.4.1             utf8_1.2.1              
#>  [94] rmarkdown_2.8            jpeg_0.1-8.1             grid_4.1.0              
#>  [97] data.table_1.14.0        digest_0.6.27            munsell_0.5.0           
#> [100] bslib_0.2.5.1