NADfinder 1.30.0
Nucleoli serve as major organizing hubs for the three-dimensional structure of mammalian heterochromatin1. Specific loci, termed nucleolar-associated domains (NADs), form frequent three-dimensional associations with nucleoli.2 Early mammalian development is a critical period to study NAD biological function, because interactions between pericentromeric chromatin and perinucleolar regions are particularly dynamic during embryonic development.4 Here, we developed a Bioconductor package NADfinder for bioinformatic analysis of the NAD-seq data, including normalization, smoothing, peak calling, peak trimming and annotation. We demonstrate the application of NADfinder in mapping the NADs in the mouse genome, determining how these associations are altered during embryonic stem cell (ESC) differentiation, and develop tools for study of these higher-order chromosome interactions in fixed and live single cells (Fig. 1).
Fig. 1 Workflow for NAD peak identification. Read counts are summarized for each 50kb moving window with step size of 1kb for nucleolar and genomic samples. Log2 ratio between nucleolar and genomic samples was computed for each window, followed by local background correction, smoothing, peak calling, filtering and annotation.
samples
Here is an example to use NADfinder for peak calling.
Here is the code snippet for calculating coverage with a sliding window in a given step along the genome using a pair of bam files from genomic sample as background and purified nucleoleus-associated DNA as target signal.
## load the library
library(NADfinder)
library(SummarizedExperiment)
## test bam files in the package
path <- system.file("extdata", package = "NADfinder", lib.loc = NULL,
            mustWork = TRUE)
bamFiles <- dir(path, ".bam$")
## window size for tile of genome. Here we set it to a big window size,
## ie., 50k because of the following two reasons:
## 1. peaks of NADs are wide;
## 2. data will be smoothed better with bigger window size.
ws <- 50000
## step for tile of genome
step <- 5000
## Set the background. 
## 0.25 means 25% of the lower ratios will be used for background training.
backgroundPercentage <- 0.25
## Count the reads for each window with a given step in the genome.
## The output will be a GRanges object.
library(BSgenome.Mmusculus.UCSC.mm10)se <- tileCount(reads=file.path(path, bamFiles), 
                genome=Mmusculus, 
                windowSize=ws, 
                step=step,
                mode = IntersectionNotStrict,
                dataOverSamples = FALSE)Here we load the pre-computed coverage data single.count to save build time.
data(single.count)
se <- single.countFor quality asessment, cumulativePercentage can be used to plot the
cumulative sums of sorted read counts for nucleolus-associated DNA and
whole genomic DNA. We expect the cumulative sum in the genomic DNA to
be close to a straight line because the coverage for the genomic DNA
sample should be uniformly distributed. Unlike ChIP-seq data, the
cumulative sum for the nucleoleus sample will not exhibit sharp changes
because most of NADs are broad regions as wide as 100 kb. However, we
should observe clear differences between the two curves.
## Calculate ratios for peak calling. We use nucleoleus vs genomic DNA.
dat <- log2se(se, nucleolusCols = "N18.subsampled.srt.bam", 
              genomeCols ="G18.subsampled.srt.bam",
              transformation = "log2CPMRatio")
## Smooth the ratios for each chromosome.
## We found that for each chromosome, the ratios are higher in 5'end than 3'end.
datList <- smoothRatiosByChromosome(dat, chr = c("chr18", "chr19"), N = 100)
## check the difference between the cumulative percentage tag allocation 
## in genome and nucleoleus samples.
cumulativePercentage(datList[["chr18"]])Before peak calling, the function smoothRatiosByChromosome is used for
log ratios calculation, normalization and smoothing.
The peaks will be called if the ratios are significantly higher than
chromosome-specific background determined by trimPeaks.
The following figure shows the peaks (black rectangles) called
using normalized (green curve) and smoothed (red curve) log2 ratios.
## check the results of smooth function
chr18 <- datList[["chr18"]] ## we only have reads in chr18 in test data.
chr18subset <- subset(chr18, seq.int(floor(length(chr18)/10))*10)
chr18 <- assays(chr18subset)
ylim <- range(c(chr18$ratio[, 1], 
                chr18$bcRatio[, 1], 
                chr18$smoothedRatio[, 1]))
plot(chr18$ratio[, 1], 
     ylim=ylim*c(.9, 1.1), 
     type="l", main="chr18")
abline(h=0, col="cyan", lty=2)
points(chr18$bcRatio[, 1], type="l", col="green")
points(chr18$smoothedRatio[, 1], type="l", col="red")
legend("topright", 
       legend = c("raw_ratio", "background_corrected", "smoothed"), 
       fill = c("black", "green", "red"))
## call peaks for each chromosome
peaks <- lapply(datList, trimPeaks, 
                backgroundPercentage=backgroundPercentage, 
                cutoffAdjPvalue=0.05, countFilter=1000)
## plot the peaks in "chr18"
peaks.subset <- countOverlaps(rowRanges(chr18subset), peaks$chr18)>=1
peaks.run <- rle(peaks.subset)
run <- cumsum(peaks.run$lengths)
run <- data.frame(x0=c(1, run[-length(run)]), x1=run)
#run <- run[peaks.run$values, , drop=FALSE]
rect(xleft = run$x0, ybottom = ylim[2]*.75, 
     xright = run$x1, ytop = ylim[2]*.8,
     col = "black")## convert list to a GRanges object
peaks.gr <- unlist(GRangesList(peaks))The following shows how to save or export the called peaks for downstream analysis.
## output the peaks
write.csv(as.data.frame(unname(peaks.gr)), "peaklist.csv", row.names=FALSE)
## export peaks to a bed file.
library(rtracklayer)
#export(peaks.gr, "peaklist.bed", "BED")Data analysis with multiple biological replicates follows the same steps as that of a single paired samples, i.e., coverage calculation, normalization and smoothing, and peak calling. The only difference is that limma is used to determine the statistical significance in peak calling.
library(NADfinder)
## bam file path
path <- system.file("extdata", package = "NADfinder", lib.loc = NULL,
            mustWork = TRUE)
bamFiles <- dir(path, ".bam$")
f <- bamFiles
ws <- 50000
step <- 5000
library(BSgenome.Mmusculus.UCSC.mm10)se <- tileCount(reads=file.path(path, f), 
                genome=Mmusculus, 
                windowSize=ws, 
                step=step)Load saved coverage.
data(triplicate.count)
se <- triplicate.count
## Calculate ratios for nucleoloar vs genomic samples.
se <- log2se(se, 
             nucleolusCols = c("N18.subsampled.srt-2.bam", 
                                "N18.subsampled.srt-3.bam",
                                "N18.subsampled.srt.bam" ),
             genomeCols = c("G18.subsampled.srt-2.bam",
                            "G18.subsampled.srt-3.bam",
                            "G18.subsampled.srt.bam"), 
             transformation = "log2CPMRatio")
seList<- smoothRatiosByChromosome(se, chr="chr18")
cumulativePercentage(seList[["chr18"]])peaks <- lapply(seList, callPeaks, 
                cutoffAdjPvalue=0.05, countFilter=1)
peaks <- unlist(GRangesList(peaks))
peaks## GRanges object with 552 ranges and 6 metadata columns:
##             seqnames            ranges strand | N18.subsampled.srt.2.bam
##                <Rle>         <IRanges>  <Rle> |                <numeric>
##     chr18.1    chr18   2956001-3138000      * |                  1.97569
##     chr18.2    chr18   3141001-3249000      * |                  2.15444
##     chr18.3    chr18   3302001-3381000      * |                  1.82705
##     chr18.4    chr18   3413001-3455000      * |                  1.91337
##     chr18.5    chr18   3480001-3510000      * |                  1.86436
##         ...      ...               ...    ... .                      ...
##   chr18.552    chr18 90001001-90086000      * |                 2.017107
##   chr18.553    chr18 90087001-90182000      * |                 2.055698
##   chr18.554    chr18 90291001-90421000      * |                 1.223125
##   chr18.555    chr18 90465001-90554000      * |                 0.849524
##   chr18.556    chr18 90645001-90649000      * |                 1.937102
##             N18.subsampled.srt.3.bam N18.subsampled.srt.bam    AveSig
##                            <numeric>              <numeric> <numeric>
##     chr18.1                  1.97569                1.97569   1.97569
##     chr18.2                  2.15444                2.15444   2.15444
##     chr18.3                  1.82705                1.82705   1.82705
##     chr18.4                  1.91337                1.91337   1.91337
##     chr18.5                  1.86436                1.86436   1.86436
##         ...                      ...                    ...       ...
##   chr18.552                 2.017107               2.017107  2.017107
##   chr18.553                 2.055698               2.055698  2.055698
##   chr18.554                 1.223125               1.223125  1.223125
##   chr18.555                 0.849524               0.849524  0.849524
##   chr18.556                 1.937102               1.937102  1.937102
##                 P.value   adj.P.Val
##               <numeric>   <numeric>
##     chr18.1 6.26990e-45  1.1357e-43
##     chr18.2 6.57176e-45  1.1357e-43
##     chr18.3 7.60885e-45  1.1357e-43
##     chr18.4 7.76846e-45  1.1357e-43
##     chr18.5 7.83128e-45  1.1357e-43
##         ...         ...         ...
##   chr18.552 6.55868e-45 1.13570e-43
##   chr18.553 7.45587e-45 1.13570e-43
##   chr18.554 1.01613e-44 1.25293e-43
##   chr18.555 9.66813e-45 1.20790e-43
##   chr18.556 2.52998e-43 1.87847e-42
##   -------
##   seqinfo: 66 sequences (1 circular) from mm10 genomeThe peaks can be visualized along the ideogram using plotSig.
ideo <- readRDS(system.file("extdata", "ideo.mm10.rds", 
                            package = "NADfinder"))
plotSig(ideo=ideo, grList=GRangesList(peaks), mcolName="AveSig", 
        layout=list("chr18"), 
        parameterList=list(types="heatmap"))sessionInfo()## R version 4.4.1 (2024-06-14)
## Platform: x86_64-pc-linux-gnu
## Running under: Ubuntu 24.04.1 LTS
## 
## Matrix products: default
## BLAS:   /home/biocbuild/bbs-3.20-bioc/R/lib/libRblas.so 
## LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.12.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:
## [1] stats4    stats     graphics  grDevices utils     datasets  methods  
## [8] base     
## 
## other attached packages:
##  [1] BSgenome.Mmusculus.UCSC.mm10_1.4.3 BSgenome_1.74.0                   
##  [3] rtracklayer_1.66.0                 BiocIO_1.16.0                     
##  [5] Biostrings_2.74.0                  XVector_0.46.0                    
##  [7] NADfinder_1.30.0                   SummarizedExperiment_1.36.0       
##  [9] Biobase_2.66.0                     MatrixGenerics_1.18.0             
## [11] matrixStats_1.4.1                  GenomicRanges_1.58.0              
## [13] GenomeInfoDb_1.42.0                IRanges_2.40.0                    
## [15] S4Vectors_0.44.0                   BiocGenerics_0.52.0               
## [17] BiocStyle_2.34.0                  
## 
## loaded via a namespace (and not attached):
##   [1] ProtGenerics_1.38.0          bitops_1.0-9                
##   [3] DirichletMultinomial_1.48.0  TFBSTools_1.44.0            
##   [5] httr_1.4.7                   RColorBrewer_1.1-3          
##   [7] InteractionSet_1.34.0        numDeriv_2016.8-1.1         
##   [9] backports_1.5.0              tools_4.4.1                 
##  [11] utf8_1.2.4                   R6_2.5.1                    
##  [13] HDF5Array_1.34.0             lazyeval_0.2.2              
##  [15] Gviz_1.50.0                  sn_2.1.1                    
##  [17] rhdf5filters_1.18.0          gridExtra_2.3               
##  [19] prettyunits_1.2.0            VennDiagram_1.7.3           
##  [21] cli_3.6.3                    formatR_1.14                
##  [23] EmpiricalBrownsMethod_1.34.0 ATACseqQC_1.30.0            
##  [25] grImport_0.9-7               sandwich_3.1-1              
##  [27] sass_0.4.9                   mvtnorm_1.3-1               
##  [29] readr_2.1.5                  randomForest_4.7-1.2        
##  [31] Rsamtools_2.22.0             txdbmaker_1.2.0             
##  [33] foreign_0.8-87               R.utils_2.12.3              
##  [35] dichromat_2.0-0.1            plotrix_3.8-4               
##  [37] limma_3.62.0                 rstudioapi_0.17.1           
##  [39] RSQLite_2.3.7                generics_0.1.3              
##  [41] gtools_3.9.5                 dplyr_1.1.4                 
##  [43] GO.db_3.20.0                 interp_1.1-6                
##  [45] Matrix_1.7-1                 futile.logger_1.4.3         
##  [47] fansi_1.0.6                  abind_1.4-8                 
##  [49] R.methodsS3_1.8.2            lifecycle_1.0.4             
##  [51] multcomp_1.4-26              yaml_2.3.10                 
##  [53] edgeR_4.4.0                  mathjaxr_1.6-0              
##  [55] rhdf5_2.50.0                 SparseArray_1.6.0           
##  [57] BiocFileCache_2.14.0         grid_4.4.1                  
##  [59] blob_1.2.4                   crayon_1.5.3                
##  [61] pwalign_1.2.0                lattice_0.22-6              
##  [63] GenomicFeatures_1.58.0       annotate_1.84.0             
##  [65] KEGGREST_1.46.0              magick_2.8.5                
##  [67] GenomicScores_2.18.0         pillar_1.9.0                
##  [69] knitr_1.48                   metapod_1.14.0              
##  [71] rjson_0.2.23                 lpSolve_5.6.21              
##  [73] codetools_0.2-20             strawr_0.0.92               
##  [75] mutoss_0.1-13                glue_1.8.0                  
##  [77] data.table_1.16.2            vctrs_0.6.5                 
##  [79] png_0.1-8                    Rdpack_2.6.1                
##  [81] gtable_0.3.6                 poweRlaw_0.80.0             
##  [83] cachem_1.1.0                 xfun_0.48                   
##  [85] rbibutils_2.3                limSolve_1.5.7.1            
##  [87] S4Arrays_1.6.0               preseqR_4.0.0               
##  [89] pracma_2.4.4                 baseline_1.3-5              
##  [91] survival_3.7-0               signal_1.8-1                
##  [93] tinytex_0.53                 statmod_1.5.0               
##  [95] TH.data_1.1-2                bit64_4.5.2                 
##  [97] progress_1.2.3               filelock_1.0.3              
##  [99] bslib_0.8.0                  rpart_4.1.23                
## [101] KernSmooth_2.23-24           colorspace_2.1-1            
## [103] seqLogo_1.72.0               DBI_1.2.3                   
## [105] Hmisc_5.2-0                  nnet_7.3-19                 
## [107] ade4_1.7-22                  motifStack_1.50.0           
## [109] mnormt_2.1.1                 tidyselect_1.2.1            
## [111] bit_4.5.0                    compiler_4.4.1              
## [113] curl_5.2.3                   httr2_1.0.5                 
## [115] graph_1.84.0                 htmlTable_2.4.3             
## [117] csaw_1.40.0                  SparseM_1.84-2              
## [119] xml2_1.3.6                   TFisher_0.2.0               
## [121] DelayedArray_0.32.0          bookdown_0.41               
## [123] checkmate_2.3.2              scales_1.3.0                
## [125] caTools_1.18.3               quadprog_1.5-8              
## [127] RBGL_1.82.0                  rappdirs_0.3.3              
## [129] stringr_1.5.1                digest_0.6.37               
## [131] rmarkdown_2.28               jpeg_0.1-10                 
## [133] base64enc_0.1-3              htmltools_0.5.8.1           
## [135] pkgconfig_2.0.3              highr_0.11                  
## [137] dbplyr_2.5.0                 regioneR_1.38.0             
## [139] fastmap_1.2.0                ensembldb_2.30.0            
## [141] rlang_1.1.4                  htmlwidgets_1.6.4           
## [143] UCSC.utils_1.2.0             jquerylib_0.1.4             
## [145] zoo_1.8-12                   jsonlite_1.8.9              
## [147] BiocParallel_1.40.0          R.oo_1.26.0                 
## [149] VariantAnnotation_1.52.0     RCurl_1.98-1.16             
## [151] magrittr_2.0.3               Formula_1.2-5               
## [153] polynom_1.4-1                GenomeInfoDbData_1.2.13     
## [155] Rhdf5lib_1.28.0              munsell_0.5.1               
## [157] Rcpp_1.0.13                  trackViewer_1.42.0          
## [159] stringi_1.8.4                zlibbioc_1.52.0             
## [161] MASS_7.3-61                  AnnotationHub_3.14.0        
## [163] plyr_1.8.9                   parallel_4.4.1              
## [165] deldir_2.0-4                 CNEr_1.42.0                 
## [167] splines_4.4.1                multtest_2.62.0             
## [169] hms_1.1.3                    locfit_1.5-9.10             
## [171] qqconf_1.3.2                 reshape2_1.4.4              
## [173] biomaRt_2.62.0               futile.options_1.0.1        
## [175] TFMPvalue_0.0.9              BiocVersion_3.20.0          
## [177] XML_3.99-0.17                evaluate_1.0.1              
## [179] metap_1.11                   universalmotif_1.24.0       
## [181] latticeExtra_0.6-30          biovizBase_1.54.0           
## [183] lambda.r_1.2.4               BiocManager_1.30.25         
## [185] tzdb_0.4.0                   tidyr_1.3.1                 
## [187] purrr_1.0.2                  ggplot2_3.5.1               
## [189] xtable_1.8-4                 restfulr_0.0.15             
## [191] AnnotationFilter_1.30.0      ChIPpeakAnno_3.40.0         
## [193] tibble_3.2.1                 memoise_2.0.1               
## [195] AnnotationDbi_1.68.0         GenomicAlignments_1.42.0    
## [197] cluster_2.1.6                corrplot_0.951. Politz, J. C. R., Scalzo, D. & Groudine, M. The redundancy of the mammalian heterochromatic compartment. Current opinion in genetics & development 37, 1–8 (2016).
2. Németh, A. et al. Initial genomics of the human nucleolus. PLoS Genet 6, e1000889 (2010).
3. Koningsbruggen, S. van et al. High-resolution whole-genome sequencing reveals that specific chromatin domains from most human chromosomes associate with nucleoli. Molecular biology of the cell 21, 3735–3748 (2010).
4. Aguirre-Lavin, T. et al. 3D-fish analysis of embryonic nuclei in mouse highlights several abrupt changes of nuclear organization during preimplantation development. BMC developmental biology 12, 1 (2012).
5. Popken, J. et al. Reprogramming of fibroblast nuclei in cloned bovine embryos involves major structural remodeling with both striking similarities and differences to nuclear phenotypes of in vitro fertilized embryos. Nucleus 5, 555–589 (2014).