CopyNeutralIMA provides reference samples for performing copy-number variation (CNV) analysis using Illumina Infinium 450k or EPIC DNA methylation arrays. There is a number of R/Bioconductor packages that do genomic copy number profiling, including conumee (Hovestadt and Zapatka, n.d.), ChAMP (Tian et al. 2017) or CopyNumber450k, now deprecated. In order to extract information about the copy number alterations, a set of copy neutral samples is required as a reference. The package CopyNumber450kData, usually used to provide the reference, is no longer available. Additionally, there has never been an effort to provide reference samples for the EPIC arrays. To fill this gap of lacking reference samples, we here introduce the CopyNeutralIMA package.
In this package we provide a set of 51 IlluminaHumanMethylation450k and 13 IlluminaHumanMethylationEPIC samples. The provided samples consist of material from healthy individuals with nominally no copy number aberrations. Users of conumee or other copy number profiling packages may use this data package as reference genomes.
We selected the data from different studies accessible in the Gene Expression Omnibus (GEO). In particular, for 450k arrays samples from GSE49618 (Ley et al. 2013), GSE61441 (Wei et al. 2015) and GSE106089 (Tomlinson et al. 2017) were chosen. For EPIC arrays, normal or control samples from series GSE86831/GSE86833 (Pidsley et al. 2016), GSE98990 (Zhou, Laird, and Shen 2017) and GSE100825 (Guastafierro et al. 2017) were chosen.
First, we load the data we want to analyse and rename it. We will use the examples provided by the minfiData (Daniel, Aryee, and Timp 2018) package and will follow the steps described in the vignette of conumee.
library(minfi)
library(conumee)
library(minfiData)
data(RGsetEx)
sampleNames(RGsetEx) <- pData(RGsetEx)$Sample_Name
cancer <- pData(RGsetEx)$status == 'cancer'
RGsetEx <- RGsetEx[,cancer]
RGsetEx
#> class: RGChannelSet 
#> dim: 622399 3 
#> metadata(0):
#> assays(2): Green Red
#> rownames(622399): 10600313 10600322 ... 74810490 74810492
#> rowData names(0):
#> colnames(3): GroupB_3 GroupB_1 GroupB_2
#> colData names(13): Sample_Name Sample_Well ... Basename filenames
#> Annotation
#>   array: IlluminaHumanMethylation450k
#>   annotation: ilmn12.hg19After loading the data we normalize it:
MsetEx <- preprocessIllumina(RGsetEx)
MsetEx
#> class: MethylSet 
#> dim: 485512 3 
#> metadata(0):
#> assays(2): Meth Unmeth
#> rownames(485512): cg00050873 cg00212031 ... ch.22.47579720R
#>   ch.22.48274842R
#> rowData names(0):
#> colnames(3): GroupB_3 GroupB_1 GroupB_2
#> colData names(13): Sample_Name Sample_Well ... Basename filenames
#> Annotation
#>   array: IlluminaHumanMethylation450k
#>   annotation: ilmn12.hg19
#> Preprocessing
#>   Method: Illumina, bg.correct = TRUE, normalize = controls, reference = 1
#>   minfi version: 1.52.0
#>   Manifest version: 0.4.0Now we load our control samples, from the same array type as our test samples and normalize them:
library(CopyNeutralIMA)
ima <- annotation(MsetEx)[['array']]
RGsetCtrl <- getCopyNeutralRGSet(ima)
# preprocess as with the sample data
MsetCtrl <- preprocessIllumina(RGsetCtrl)
MsetCtrl
#> class: MethylSet 
#> dim: 485512 51 
#> metadata(0):
#> assays(2): Meth Unmeth
#> rownames(485512): cg00050873 cg00212031 ... ch.22.47579720R
#>   ch.22.48274842R
#> rowData names(0):
#> colnames(51): GSM1185582 GSM1185583 ... GSM2829413 GSM2829418
#> colData names(7): ID gsm ... source_name_ch1 characteristics_ch1
#> Annotation
#>   array: IlluminaHumanMethylation450k
#>   annotation: ilmn12.hg19
#> Preprocessing
#>   Method: Illumina, bg.correct = TRUE, normalize = controls, reference = 1
#>   minfi version: 1.52.0
#>   Manifest version: 0.4.0Finally we can run the conumee analysis following the author’s indications:
# use the information provided by conumee to create annotation files or define
# them according to the package instructions
data(exclude_regions)
data(detail_regions)
anno <- CNV.create_anno(array_type = "450k", exclude_regions = exclude_regions, detail_regions = detail_regions)
#> using genome annotations from UCSC
#> getting 450k annotations
#>  - 470870 probes used
#> importing regions to exclude from analysis
#> importing regions for detailed analysis
#> creating bins
#>  - 53891 bins created
#> merging bins
#>  - 15820 bins remaining
# load in the data from the reference and samples to be analyzed
control.data <- CNV.load(MsetCtrl)
ex.data <- CNV.load(MsetEx)
cnv <- CNV.fit(ex.data["GroupB_1"], control.data, anno)
cnv <- CNV.bin(cnv)
cnv <- CNV.detail(cnv)
cnv <- CNV.segment(cnv)
cnv
#> CNV analysis object
#>    created   : Thu Oct 31 12:32:43 2024
#>   @name      : GroupB_1
#>   @anno      : 22 chromosomes, 470870 probes, 15820 bins
#>   @fit       : available (noise: 2.32)
#>   @bin       : available (shift: 0.005)
#>   @detail    : available (20 regions)
#>   @seg       : available (29 segments)
CNV.genomeplot(cnv)CNV.genomeplot(cnv, chr = 'chr18')
head(CNV.write(cnv, what = 'segments'))
#>         ID chrom loc.start   loc.end num.mark     bstat          pval seg.mean
#> 1 GroupB_1  chr1    635684 148927230      931 21.475711  1.422312e-99   -0.194
#> 2 GroupB_1  chr1 149077230 149379823        5 26.044755 7.787661e-147    3.058
#> 3 GroupB_1  chr1 149579823 249195311      657        NA            NA   -0.077
#> 4 GroupB_1 chr10    105000 135462374      840        NA            NA   -0.054
#> 5 GroupB_1 chr11    130000 134873258      914        NA            NA    0.081
#> 6 GroupB_1 chr12    172870  65175000      413  8.802509  1.958883e-16   -0.006
#>   seg.median
#> 1     -0.180
#> 2      0.621
#> 3     -0.070
#> 4     -0.050
#> 5      0.068
#> 6     -0.015
head(CNV.write(cnv, what='probes'))
#>   Chromosome Start   End    Feature GroupB_1
#> 1       chr1 15864 15865 cg13869341   -0.064
#> 2       chr1 18826 18827 cg14008030   -0.321
#> 3       chr1 29406 29407 cg12045430    0.109
#> 4       chr1 29424 29425 cg20826792   -0.264
#> 5       chr1 29434 29435 cg00381604   -0.069
#> 6       chr1 68848 68849 cg20253340   -0.360#> 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] parallel  stats4    stats     graphics  grDevices utils     datasets 
#> [8] methods   base     
#> 
#> other attached packages:
#>  [1] CopyNeutralIMA_1.24.0                              
#>  [2] minfiData_0.52.0                                   
#>  [3] conumee_1.40.0                                     
#>  [4] IlluminaHumanMethylationEPICmanifest_0.3.0         
#>  [5] IlluminaHumanMethylationEPICanno.ilm10b2.hg19_0.6.0
#>  [6] IlluminaHumanMethylation450kmanifest_0.4.0         
#>  [7] IlluminaHumanMethylation450kanno.ilmn12.hg19_0.6.1 
#>  [8] minfi_1.52.0                                       
#>  [9] bumphunter_1.48.0                                  
#> [10] locfit_1.5-9.10                                    
#> [11] iterators_1.0.14                                   
#> [12] foreach_1.5.2                                      
#> [13] Biostrings_2.74.0                                  
#> [14] XVector_0.46.0                                     
#> [15] SummarizedExperiment_1.36.0                        
#> [16] Biobase_2.66.0                                     
#> [17] MatrixGenerics_1.18.0                              
#> [18] matrixStats_1.4.1                                  
#> [19] GenomicRanges_1.58.0                               
#> [20] GenomeInfoDb_1.42.0                                
#> [21] IRanges_2.40.0                                     
#> [22] S4Vectors_0.44.0                                   
#> [23] BiocGenerics_0.52.0                                
#> [24] BiocStyle_2.34.0                                   
#> 
#> loaded via a namespace (and not attached):
#>   [1] RColorBrewer_1.1-3        jsonlite_1.8.9           
#>   [3] magrittr_2.0.3            magick_2.8.5             
#>   [5] GenomicFeatures_1.58.0    rmarkdown_2.28           
#>   [7] BiocIO_1.16.0             zlibbioc_1.52.0          
#>   [9] vctrs_0.6.5               multtest_2.62.0          
#>  [11] memoise_2.0.1             Rsamtools_2.22.0         
#>  [13] DelayedMatrixStats_1.28.0 RCurl_1.98-1.16          
#>  [15] askpass_1.2.1             tinytex_0.53             
#>  [17] htmltools_0.5.8.1         S4Arrays_1.6.0           
#>  [19] AnnotationHub_3.14.0      curl_5.2.3               
#>  [21] Rhdf5lib_1.28.0           SparseArray_1.6.0        
#>  [23] rhdf5_2.50.0              sass_0.4.9               
#>  [25] nor1mix_1.3-3             bslib_0.8.0              
#>  [27] plyr_1.8.9                cachem_1.1.0             
#>  [29] GenomicAlignments_1.42.0  mime_0.12                
#>  [31] lifecycle_1.0.4           pkgconfig_2.0.3          
#>  [33] Matrix_1.7-1              R6_2.5.1                 
#>  [35] fastmap_1.2.0             rbibutils_2.3            
#>  [37] GenomeInfoDbData_1.2.13   digest_0.6.37            
#>  [39] siggenes_1.80.0           reshape_0.8.9            
#>  [41] AnnotationDbi_1.68.0      ExperimentHub_2.14.0     
#>  [43] RSQLite_2.3.7             base64_2.0.2             
#>  [45] filelock_1.0.3            fansi_1.0.6              
#>  [47] httr_1.4.7                abind_1.4-8              
#>  [49] compiler_4.4.1            beanplot_1.3.1           
#>  [51] rngtools_1.5.2            withr_3.0.2              
#>  [53] bit64_4.5.2               BiocParallel_1.40.0      
#>  [55] DBI_1.2.3                 highr_0.11               
#>  [57] HDF5Array_1.34.0          MASS_7.3-61              
#>  [59] openssl_2.2.2             rappdirs_0.3.3           
#>  [61] DelayedArray_0.32.0       rjson_0.2.23             
#>  [63] DNAcopy_1.80.0            tools_4.4.1              
#>  [65] rentrez_1.2.3             glue_1.8.0               
#>  [67] quadprog_1.5-8            restfulr_0.0.15          
#>  [69] nlme_3.1-166              rhdf5filters_1.18.0      
#>  [71] grid_4.4.1                generics_0.1.3           
#>  [73] tzdb_0.4.0                preprocessCore_1.68.0    
#>  [75] tidyr_1.3.1               data.table_1.16.2        
#>  [77] hms_1.1.3                 xml2_1.3.6               
#>  [79] utf8_1.2.4                BiocVersion_3.20.0       
#>  [81] pillar_1.9.0              limma_3.62.0             
#>  [83] genefilter_1.88.0         splines_4.4.1            
#>  [85] dplyr_1.1.4               BiocFileCache_2.14.0     
#>  [87] lattice_0.22-6            survival_3.7-0           
#>  [89] rtracklayer_1.66.0        bit_4.5.0                
#>  [91] GEOquery_2.74.0           annotate_1.84.0          
#>  [93] tidyselect_1.2.1          knitr_1.48               
#>  [95] bookdown_0.41             xfun_0.48                
#>  [97] scrime_1.3.5              statmod_1.5.0            
#>  [99] UCSC.utils_1.2.0          yaml_2.3.10              
#> [101] evaluate_1.0.1            codetools_0.2-20         
#> [103] tibble_3.2.1              BiocManager_1.30.25      
#> [105] cli_3.6.3                 Rdpack_2.6.1             
#> [107] xtable_1.8-4              jquerylib_0.1.4          
#> [109] Rcpp_1.0.13               dbplyr_2.5.0             
#> [111] png_0.1-8                 XML_3.99-0.17            
#> [113] readr_2.1.5               blob_1.2.4               
#> [115] mclust_6.1.1              doRNG_1.8.6              
#> [117] sparseMatrixStats_1.18.0  bitops_1.0-9             
#> [119] illuminaio_0.48.0         purrr_1.0.2              
#> [121] crayon_1.5.3              rlang_1.1.4              
#> [123] KEGGREST_1.46.0Aryee, MJ, AE Jaffe, H Corrada-Bravo, C Ladd-Acosta, AP Feinberg, KD Hansen, and RA Irizarry. 2014. “Minfi: A flexible and comprehensive Bioconductor package for the analysis of Infinium DNA Methylation microarrays.” Bioinformatics 30 (10): 1363–9. https://doi.org/10.1093/bioinformatics/btu049.
Daniel, K, M Aryee, and W Timp. 2018. minfiData: Example data for the Illumina Methylation 450k array.
Guastafierro, T, MG Bacalini, A Marcoccia, D Gentilini, S Pisoni, AM Di Blasio, A Corsi, et al. 2017. “Genome-wide DNA methylation analysis in blood cells from patients with Werner syndrome.” Clinical Epigenetics 9: 92. https://doi.org/10.1186/s13148-017-0389-4.
Hovestadt, V, and M Zapatka. n.d. conumee: Enhanced copy-number variation analysis using Illumina DNA methylation arrays. Division of Molecular Genetics, German Cancer Research Center (DKFZ), Heidelberg, Germany. http://bioconductor.org/packages/conumee/.
Ley, TJ, C Miller, L Ding, and The Cancer Genome Atlas Research Network. 2013. “Genomic and epigenomic landscapes of adult de novo acute myeloid leukemia.” The New England of Journal Medicine 368 (22): 2059–74. https://doi.org/10.1056/NEJMoa1301689.
Pidsley, R, E Zotenko, TJ Peters, MG Lawrence, GP Risbridger, P Molloy, S Van Djik, B Muhlhausler, C Stirzaker, and SJ Clark. 2016. “Critical evaluation of the Illumina MethylationEPIC BeadChip microarray for whole-genome DNA methylation profiling.” Genome Biology 17 (1): 208. https://doi.org/10.1186/s13059-016-1066-1.
Tian, Y, TJ Morris, AP Webster, Z Yang, S Beck, A Feber, and AE Teschendorff. 2017. “ChAMP: updated methylatioon analysis pipeline for Illumina BeadChips.” Bioinformatics 33 (24): 3982–4. https://doi.org/10.1093/bioinformatics/btx513.
Tomlinson, MS, PA Bommarito, EM Martin, L Smeester, RN Fichorova, AB Onderdonk, KCK Kuban, TM O’Shea, and RC Fry. 2017. “Microorganisms in the human placenta are associated with altered CpG methylation of immune and inflammation-related genes.” PLoS One 12 (12): e0188664. https://doi.org/10.1371/journal.pone.0188664.
Wei, JH, A Haddad, JH Luo, and others. 2015. “A CpG-methylation-based assay to predict survival in clear cell renal cell carcinoma.” Nature Communications 30 (6): 8699. https://doi.org/10.1038/ncomms9699.
Zhou, W, PW Laird, and H Shen. 2017. “Comprehensive characterization, annotation and innovative use of Infinium DNA methylation BeadChip probes.” Nucleic Acids Research 45 (4): e22. https://doi.org/10.1093/nar/gkw967.