The aim of HiCDOC is to detect significant A/B compartment changes, using Hi-C data with replicates.
HiCDOC normalizes intrachromosomal Hi-C matrices, uses unsupervised learning to predict A/B compartments from multiple replicates, and detects significant compartment changes between experiment conditions.
It provides a collection of functions assembled into a pipeline:
HiCDOC can be installed from Bioconductor:
if (!requireNamespace("BiocManager", quietly=TRUE))
    install.packages("BiocManager")
BiocManager::install("HiCDOC")The package can then be loaded:
library(HiCDOC)
#> Loading required package: InteractionSet
#> Loading required package: GenomicRanges
#> Loading required package: stats4
#> Loading required package: BiocGenerics
#> 
#> Attaching package: 'BiocGenerics'
#> 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, aperm, 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 object is masked from 'package:utils':
#> 
#>     findMatches
#> The following objects are masked from 'package:base':
#> 
#>     I, expand.grid, unname
#> Loading required package: IRanges
#> Loading required package: GenomeInfoDb
#> 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: 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, rowMediansHiCDOC can import Hi-C data sets in various different formats:
- Tabular .tsv files.
- Cooler .cool or .mcool files.
- Juicer .hic files.
- HiC-Pro .matrix and .bed files.
A tabular file is a tab-separated multi-replicate sparse matrix with a header:
chromosome position 1 position 2 C1.R1 C1.R2 C2.R1 … Y 1500000 7500000 145 184 72 … …
The number of interactions between position 1 and position 2 of
chromosome are reported in each condition.replicate column. There is no
limit to the number of conditions and replicates.
To load Hi-C data in this format:
hic.experiment <- HiCDOCDataSetFromTabular('path/to/data.tsv')To load .cool or .mcool files generated by Cooler
(Abdennur and Mirny 2019):
# Path to each file
paths = c(
    'path/to/condition-1.replicate-1.cool',
    'path/to/condition-1.replicate-2.cool',
    'path/to/condition-2.replicate-1.cool',
    'path/to/condition-2.replicate-2.cool',
    'path/to/condition-3.replicate-1.cool'
)
# Replicate and condition of each file. Can be names instead of numbers.
replicates <- c(1, 2, 1, 2, 1)
conditions <- c(1, 1, 2, 2, 3)
# Resolution to select in .mcool files
binSize = 500000
# Instantiation of data set
hic.experiment <- HiCDOCDataSetFromCool(
    paths,
    replicates = replicates,
    conditions = conditions,
    binSize = binSize # Specified for .mcool files.
)To load .hic files generated by Juicer (Durand 2016):
# Path to each file
paths = c(
    'path/to/condition-1.replicate-1.hic',
    'path/to/condition-1.replicate-2.hic',
    'path/to/condition-2.replicate-1.hic',
    'path/to/condition-2.replicate-2.hic',
    'path/to/condition-3.replicate-1.hic'
)
# Replicate and condition of each file. Can be names instead of numbers.
replicates <- c(1, 2, 1, 2, 1)
conditions <- c(1, 1, 2, 2, 3)
# Resolution to select
binSize <- 500000
# Instantiation of data set
hic.experiment <- HiCDOCDataSetFromHiC(
    paths,
    replicates = replicates,
    conditions = conditions,
    binSize = binSize
)To load .matrix and .bed files generated by HiC-Pro
(Servant 2015):
# Path to each matrix file
matrixPaths = c(
    'path/to/condition-1.replicate-1.matrix',
    'path/to/condition-1.replicate-2.matrix',
    'path/to/condition-2.replicate-1.matrix',
    'path/to/condition-2.replicate-2.matrix',
    'path/to/condition-3.replicate-1.matrix'
)
# Path to each bed file
bedPaths = c(
    'path/to/condition-1.replicate-1.bed',
    'path/to/condition-1.replicate-2.bed',
    'path/to/condition-2.replicate-1.bed',
    'path/to/condition-2.replicate-2.bed',
    'path/to/condition-3.replicate-1.bed'
)
# Replicate and condition of each file. Can be names instead of numbers.
replicates <- c(1, 2, 1, 2, 1)
conditions <- c(1, 1, 2, 2, 3)
# Instantiation of data set
hic.experiment <- HiCDOCDataSetFromHiCPro(
    matrixPaths = matrixPaths,
    bedPaths = bedPaths,
    replicates = replicates,
    conditions = conditions
)An example dataset can be loaded from the HiCDOC package:
data(exampleHiCDOCDataSet)Once your data is loaded, you can run all the filtering, normalization, and
prediction steps with the command : HiCDOC(exampleHiCDOCDataSet).
This one-liner runs all the steps detailed below.
Remove small chromosomes of length smaller than 100 positions (100 is the default value):
hic.experiment <- filterSmallChromosomes(exampleHiCDOCDataSet, threshold = 100)
#> Keeping chromosomes with at least 100 positions.
#> Kept 3 chromosomes: X, Y, Z
#> Removed 1 chromosome: WRemove sparse replicates filled with less than 30% non-zero interactions (30% is the default value):
hic.experiment <- filterSparseReplicates(hic.experiment, threshold = 0.3)
#> Keeping replicates filled with at least 30% non-zero interactions.
#> 
#> Removed interactions matrix of chromosome X, condition 1, replicate R2 filled at 2.347%.
#> Removed 1 replicate in total.Remove weak positions with less than 1 interaction in average (1 is the default value):
hic.experiment <- filterWeakPositions(hic.experiment, threshold = 1)
#> Keeping positions with interactions average greater or equal to 1.
#> Chromosome X: 2 positions removed, 118 positions remaining.
#> Chromosome Y: 3 positions removed, 157 positions remaining.
#> Chromosome Z: 0 positions removed, 200 positions remaining.
#> Removed 5 positions in total.Normalize technical biases such as sequencing depth (inter-matrix normalization):
suppressWarnings(hic.experiment <- normalizeTechnicalBiases(hic.experiment))
#> Normalizing technical biases.Normalize biological biases, such as GC content, number of restriction sites, etc. (intra-matrix normalization):
hic.experiment <- normalizeBiologicalBiases(hic.experiment)
#> Chromosome X: normalizing biological biases.
#> Chromosome Y: normalizing biological biases.
#> Chromosome Z: normalizing biological biases.Normalize the linear distance effect resulting from more interactions between
closer genomic regions (20000 is the default value for loessSampleSize):
hic.experiment <- 
    normalizeDistanceEffect(hic.experiment, loessSampleSize = 20000)
#> Chromosome X: normalizing distance effect.
#> Chromosome Y: normalizing distance effect.
#> Chromosome Z: normalizing distance effect.Predict A and B compartments and detect significant differences, here using the default values as parameters:
hic.experiment <- detectCompartments(
    hic.experiment,
    kMeansDelta = 0.0001,
    kMeansIterations = 50,
    kMeansRestarts = 20
)
#> Clustering genomic positions.
#> Predicting A/B compartments.
#> Detecting significant differences.Plot the interaction matrix of each replicate:
p <- plotInteractions(hic.experiment, chromosome = "Y")
pPlot the overall distance effect on the proportion of interactions:
p <- plotDistanceEffect(hic.experiment)
#> `geom_smooth()` using method = 'gam' and formula = 'y ~ s(x, bs = "cs")'
#> `geom_smooth()` using method = 'gam' and formula = 'y ~ s(x, bs = "cs")'
#> `geom_smooth()` using method = 'gam' and formula = 'y ~ s(x, bs = "cs")'
pList and plot compartments with their concordance (confidence measure) in each replicate, and significant changes between experiment conditions:
compartments(hic.experiment)
#> GRanges object with 1025 ranges and 6 metadata columns:
#>          seqnames      ranges strand |     index condition compartment
#>             <Rle>   <IRanges>  <Rle> | <numeric>  <factor>    <factor>
#>      [1]        X       1-137      * |        81         1           A
#>      [2]        X       1-137      * |        81         2           A
#>      [3]        X       1-137      * |        81         3           A
#>      [4]        X     138-274      * |        82         1           A
#>      [5]        X     138-274      * |        82         2           A
#>      ...      ...         ...    ... .       ...       ...         ...
#>   [1021]        Z 26716-26852      * |       556         1           A
#>   [1022]        Z 26853-26989      * |       557         1           A
#>   [1023]        Z 26990-27126      * |       558         1           A
#>   [1024]        Z 27127-27263      * |       559         1           A
#>   [1025]        Z 27264-27400      * |       560         1           A
#>          centroid.check PC1.check assignment.check
#>               <logical> <logical>        <logical>
#>      [1]           TRUE      TRUE             TRUE
#>      [2]           TRUE      TRUE             TRUE
#>      [3]           TRUE      TRUE             TRUE
#>      [4]           TRUE      TRUE             TRUE
#>      [5]           TRUE      TRUE             TRUE
#>      ...            ...       ...              ...
#>   [1021]           TRUE      TRUE             TRUE
#>   [1022]           TRUE      TRUE             TRUE
#>   [1023]           TRUE      TRUE             TRUE
#>   [1024]           TRUE      TRUE             TRUE
#>   [1025]           TRUE      TRUE             TRUE
#>   -------
#>   seqinfo: 3 sequences from an unspecified genome; no seqlengthsconcordances(hic.experiment)
#> GRanges object with 2089 ranges and 5 metadata columns:
#>          seqnames      ranges strand |     index condition replicate
#>             <Rle>   <IRanges>  <Rle> | <numeric>  <factor>  <factor>
#>      [1]        X       1-137      * |        81         1        R1
#>      [2]        X       1-137      * |        81         1        R3
#>      [3]        X       1-137      * |        81         2        R2
#>      [4]        X       1-137      * |        81         3        R1
#>      [5]        X       1-137      * |        81         3        R2
#>      ...      ...         ...    ... .       ...       ...       ...
#>   [2085]        Z 26990-27126      * |       558         1        R3
#>   [2086]        Z 27127-27263      * |       559         1        R2
#>   [2087]        Z 27127-27263      * |       559         1        R3
#>   [2088]        Z 27264-27400      * |       560         1        R2
#>   [2089]        Z 27264-27400      * |       560         1        R3
#>          compartment concordance
#>             <factor>   <numeric>
#>      [1]           A  -0.0139970
#>      [2]           A  -0.0132523
#>      [3]           B  -0.0200731
#>      [4]           B  -0.0160541
#>      [5]           B  -0.0161278
#>      ...         ...         ...
#>   [2085]           A  -0.0214114
#>   [2086]           A  -0.0212561
#>   [2087]           A  -0.0256792
#>   [2088]           A  -0.0221277
#>   [2089]           A  -0.0230500
#>   -------
#>   seqinfo: 3 sequences from an unspecified genome; no seqlengthsdifferences(hic.experiment)
#> GRanges object with 54 ranges and 10 metadata columns:
#>        seqnames      ranges strand |     index condition.1 condition.2
#>           <Rle>   <IRanges>  <Rle> | <numeric>    <factor>    <factor>
#>    [1]        X   1645-1781      * |        93           1           2
#>    [2]        X   1645-1781      * |        93           2           3
#>    [3]        X   1782-1918      * |        94           1           2
#>    [4]        X   1782-1918      * |        94           2           3
#>    [5]        X   1919-2055      * |        95           1           2
#>    ...      ...         ...    ... .       ...         ...         ...
#>   [50]        Y 14660-14796      * |       308           2           3
#>   [51]        Y 14797-14933      * |       309           1           3
#>   [52]        Y 14797-14933      * |       309           2           3
#>   [53]        Y 14934-15070      * |       310           1           3
#>   [54]        Y 14934-15070      * |       310           2           3
#>           pvalue pvalue.adjusted direction significance centroid.check
#>        <numeric>       <numeric>  <factor>  <character>      <logical>
#>    [1]         0               0      A->B         ****           TRUE
#>    [2]         0               0      B->A         ****           TRUE
#>    [3]         0               0      A->B         ****           TRUE
#>    [4]         0               0      B->A         ****           TRUE
#>    [5]         0               0      A->B         ****           TRUE
#>    ...       ...             ...       ...          ...            ...
#>   [50]         0               0      B->A         ****           TRUE
#>   [51]         0               0      B->A         ****           TRUE
#>   [52]         0               0      B->A         ****           TRUE
#>   [53]         0               0      B->A         ****           TRUE
#>   [54]         0               0      B->A         ****           TRUE
#>        PC1.check assignment.check
#>        <logical>        <logical>
#>    [1]      TRUE             TRUE
#>    [2]      TRUE             TRUE
#>    [3]      TRUE             TRUE
#>    [4]      TRUE             TRUE
#>    [5]      TRUE             TRUE
#>    ...       ...              ...
#>   [50]      TRUE             TRUE
#>   [51]      TRUE             TRUE
#>   [52]      TRUE             TRUE
#>   [53]      TRUE             TRUE
#>   [54]      TRUE             TRUE
#>   -------
#>   seqinfo: 3 sequences from an unspecified genome; no seqlengthsp <- plotCompartmentChanges(hic.experiment, chromosome = "Y")
pPlot the overall distribution of concordance differences:
p <- plotConcordanceDifferences(hic.experiment)
p
#> `stat_bin()` using `bins = 30`. Pick better value with `binwidth`.Plot the result of the PCA on the compartments’ centroids:
p <- plotCentroids(hic.experiment, chromosome = "Y")
pPlot the boxplots of self interaction ratios (differences between self interactions and the median of other interactions) of each compartment:
p <- plotSelfInteractionRatios(hic.experiment, chromosome = "Y")
pSometimes, basic assumptions on the data are not met. We try to detect inconsistencies, and warn the user.
We perform a principal component analysis on the centroids. Each centroid represent an ideal bin, located either on compartment A or B, in each sample, and each chromosome. Given a chromosome, if all the centroids of the A compartment do not have the same sign on the first principal component, we issue a warning for this chromosome. Likewise for the B compartment.
We also check that the inertia on the first principal component is at least 75%.
These checks make sure that centroids of the same compartments do cluster together. If the conditions are too different from each other, they may cluster together. This case is detected by this check.
We use “self-interaction” in order to classify centroids to A and B compartments. The self-interaction of a bin is the ratio of the number of pairs that link this bin with other bins of the same compartment, divided by the number of pairs The self-interactions should be different from compartments A and B. We perform a Wilcoxon t-test. If it is not significant, then a warning is issued.
If at least of the PCA checks fail, the warnings are printed on the PCA plot. If the compartment assignment check fail, the warning is printed on the corresponding plot.
When accessing the compartments and the concordances, chromosomes which fail to pass the checks are removed (unless the appropriate parameter is set).
sessionInfo()
#> R version 4.3.0 RC (2023-04-13 r84269)
#> Platform: x86_64-pc-linux-gnu (64-bit)
#> Running under: Ubuntu 22.04.2 LTS
#> 
#> Matrix products: default
#> BLAS:   /home/biocbuild/bbs-3.17-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:
#> [1] stats4    stats     graphics  grDevices utils     datasets  methods  
#> [8] base     
#> 
#> other attached packages:
#>  [1] HiCDOC_1.2.0                InteractionSet_1.28.0      
#>  [3] SummarizedExperiment_1.30.0 Biobase_2.60.0             
#>  [5] MatrixGenerics_1.12.0       matrixStats_0.63.0         
#>  [7] GenomicRanges_1.52.0        GenomeInfoDb_1.36.0        
#>  [9] IRanges_2.34.0              S4Vectors_0.38.0           
#> [11] BiocGenerics_0.46.0         BiocStyle_2.28.0           
#> 
#> loaded via a namespace (and not attached):
#>   [1] bitops_1.0-7            pbapply_1.7-0           gridExtra_2.3          
#>   [4] rlang_1.1.0             magrittr_2.0.3          aggregation_1.0.1      
#>   [7] compiler_4.3.0          mgcv_1.8-42             vctrs_0.6.2            
#>  [10] pkgconfig_2.0.3         crayon_1.5.2            fastmap_1.1.1          
#>  [13] magick_2.7.4            backports_1.4.1         XVector_0.40.0         
#>  [16] ellipsis_0.3.2          labeling_0.4.2          utf8_1.2.3             
#>  [19] Rsamtools_2.16.0        promises_1.2.0.1        rmarkdown_2.21         
#>  [22] purrr_1.0.1             xfun_0.39               zlibbioc_1.46.0        
#>  [25] cachem_1.0.7            QDNAseq_1.36.0          jsonlite_1.8.4         
#>  [28] highr_0.10              later_1.3.0             rhdf5filters_1.12.0    
#>  [31] DelayedArray_0.26.0     Rhdf5lib_1.22.0         BiocParallel_1.34.0    
#>  [34] broom_1.0.4             parallel_4.3.0          R6_2.5.1               
#>  [37] RColorBrewer_1.1-3      bslib_0.4.2             limma_3.56.0           
#>  [40] parallelly_1.35.0       car_3.1-2               DNAcopy_1.74.0         
#>  [43] jquerylib_0.1.4         Rcpp_1.0.10             bookdown_0.33          
#>  [46] knitr_1.42              future.apply_1.10.0     R.utils_2.12.2         
#>  [49] splines_4.3.0           httpuv_1.6.9            Matrix_1.5-4           
#>  [52] tidyselect_1.2.0        abind_1.4-5             yaml_2.3.7             
#>  [55] codetools_0.2-19        miniUI_0.1.1.1          listenv_0.9.0          
#>  [58] lattice_0.21-8          tibble_3.2.1            withr_2.5.0            
#>  [61] shiny_1.7.4             evaluate_0.20           future_1.32.0          
#>  [64] Biostrings_2.68.0       pillar_1.9.0            BiocManager_1.30.20    
#>  [67] ggpubr_0.6.0            carData_3.0-5           multiHiCcompare_1.18.0 
#>  [70] KernSmooth_2.23-20      generics_0.1.3          RCurl_1.98-1.12        
#>  [73] ggplot2_3.4.2           munsell_0.5.0           scales_1.2.1           
#>  [76] HiCcompare_1.22.0       calibrate_1.7.7         globals_0.16.2         
#>  [79] gtools_3.9.4            xtable_1.8-4            marray_1.78.0          
#>  [82] glue_1.6.2              pheatmap_1.0.12         tools_4.3.0            
#>  [85] data.table_1.14.8       locfit_1.5-9.7          ggsignif_0.6.4         
#>  [88] cowplot_1.1.1           rhdf5_2.44.0            grid_4.3.0             
#>  [91] impute_1.74.0           tidyr_1.3.0             edgeR_3.42.0           
#>  [94] colorspace_2.1-0        nlme_3.1-162            GenomeInfoDbData_1.2.10
#>  [97] cli_3.6.1               fansi_1.0.4             dplyr_1.1.2            
#> [100] CGHcall_2.62.0          gtable_0.3.3            R.methodsS3_1.8.2      
#> [103] rstatix_0.7.2           sass_0.4.5              digest_0.6.31          
#> [106] CGHbase_1.60.0          farver_2.1.1            htmltools_0.5.5        
#> [109] R.oo_1.25.0             lifecycle_1.0.3         mime_0.12              
#> [112] MASS_7.3-59             qqman_0.1.8             ggExtra_0.10.0Abdennur, Nezar, and Leonid A Mirny. 2019. “Cooler: scalable storage for Hi-C data and other genomically labeled arrays.” Bioinformatics 36: 311–16. https://doi.org/10.1093/bioinformatics/btz540.
Durand, Muhammad S. AND Machol, Neva C. AND Shamim. 2016. “Juicer Provides a One-Click System for Analyzing Loop-Resolution Hi-C Experiments.” Cell Systems 3: 95–98. https://doi.org/10.1016/j.cels.2016.07.002.
Knight, Philip A., and Daniel Ruiz. 2012. “A fast algorithm for matrix balancing.” IMA Journal of Numerical Analysis 33: 1029–47. https://doi.org/10.1093/imanum/drs019.
Servant, Nelle AND Lajoie, Nicolas AND Varoquaux. 2015. “HiC-Pro: an optimized and flexible pipeline for Hi-C data processing.” Genome Biology 16: 259. https://doi.org/10.1186/s13059-015-0831-x.
Stansfield, John C, Kellen G Cresswell, and Mikhail G Dozmorov. 2019. “multiHiCcompare: joint normalization and comparative analysis of complex Hi-C experiments.” Bioinformatics 35: 2916–23. https://doi.org/10.1093/bioinformatics/btz048.
Wagstaff, Kiri, Claire Cardie, Seth Rogers, and Stefan Schrödl. 2001. “Constrained K-Means Clustering with Background Knowledge.” In Proceedings of the Eighteenth International Conference on Machine Learning, 577–84. ICML ’01. https://pdfs.semanticscholar.org/0bac/ca0993a3f51649a6bb8dbb093fc8d8481ad4.pdf.