This protocol provides detailed instructions on Quality Control, EWAS, and CpG island signature discovery with Illumina Infinitum MethylationEPIC and Infinium Human Methylation 450K BeadChip data. R package minfi and caret was used in this analysis.
Method Article
DNA methylation signatures analysis with Illumina Infinitum MethylationEPIC and Infinium Human Methylation 450K BeadChip
https://doi.org/10.1038/protex.2017.135
This work is licensed under a CC BY 4.0 License
This protocol has been posted on Protocol Exchange, an open repository of community-contributed protocols sponsored by Nature Portfolio. These protocols are posted directly on the Protocol Exchange by authors and are made freely available to the scientific community for use and comment.
posted
You are reading this latest protocol version
This protocol provides detailed instructions on Quality Control, EWAS, and CpG island signature discovery with Illumina Infinitum MethylationEPIC and Infinium Human Methylation 450K BeadChip data. R package minfi and caret was used in this analysis.
IDU HCV 450K EPIC signature CpG island
This protocol provides a pipeline for a two-stage genome-wide DNA methylation analysis for HIV-infected IDU in African American male.
All subjects were from a well-established longitudinal cohort, Veteran Aging Cohort Study (VACS).
DNA samples were isolated from whole blood.
DNA methylation profile: Illumina HumanMethylation 450k Beadchip.
The replication analysis was based on Illumina EPIC BeadChip.
Analysis pipeline:
Figure 1 Analysis workflow
Computer with at least 2 GB of RAM (Linux server required for large data set, but PC and Mac are also OK with the data set used in this protocol)
High performance computer system with Linux system.
R ver >= 3.3.3
minfi ver >= 1.18.1
caret ver >= 6.0-77
1 a) download raw data:
Illumina Infinium Human Methylation 450K BeadChip Discovery Data:
https://www.ncbi.nlm.nih.gov/geo/query/acc.cgi?acc=GSE100264
Illumina Infinium MethylationEPIC BeadChip Replication Data:
https://www.synapse.org/#!Synapse:syn11455620
1 b). Detection Pvalue determination
A total of 416 probes on chromosome Y were selected.
A set of p-values, 5e-2, 1e-2, 1e-5, 1e-8, 1e-10, 1e-12, … 1e-30, was used to calculate the call rate of each female subject using the 416 probes.
A detection p-value was chosen considering ratio of non-0-call-rate subjects, and not too stringent to exclude too many signals.
Finally, the intensity values with detection P ≥ 1e-12 were set to missing data.
Figure 2 450K Pvalue determination
1 c) Data QC
The data quality was checked by using minfi R package.
Probe QC:
All the probes located in sex chromosome probes and within 10 bp SNP were removed.
Sex chromosome: 11,648 probes on sex chromosomes
Within 10 bp SNP: 36,142 probes within 10 bp SNPs.
A total of 437,722 probes remained after removing the above probes.
Sample QC:
We determined the proportion of missing data per sample, enabling calculation of the sample call rate, and excluded samples with sample call rate < 98%. We also compared the predicted sex with the self-reported sex. One sex mismatched sample and three samples with lower call rate than 0.98 were found and excluded in the further analysis.
Figure 3 sex prediction results
Figure 4 whole beta value distribution
Figure 5 sample data quality check
R code:
#############################
qc <- getQC(MSet)
head(qc)
#plot QC
plotQC(qc)
#check sex
plotSex(getSex(gRatioSet.quantile, cutoff = -2))
#############################
1 d) Intensity data processing and normalization
Background correction and within array normalization was conducted with preprocessIllumina function in minfi package. The original Green/Red channel intensity data was also transformed to Meth/Unmeth data.
All probes were divided to 3 types: Type I Green, Type I Red, and Type II.
Meth/Unmeth data were subsequently divided into 6 groups: Meth and Unmeth for each type as above.
Each group was normalized independently by using normalizeBetweenArrays function in Limma R package (version 3.26.2), and then were merged. Then Beta value of each probe was generated using getBeta function in minfi.
R code:
#############################
#background correction & within-array normalization
MSet.illumina <- preprocessIllumina(RGSet, bg.correct = TRUE,
normalize = "controls")
#between-array normalization after dividing the signals into 6 parts
meth.1 = normalizeBetweenArrays(my.meth[typeIProbesGrn,])
meth.2 = normalizeBetweenArrays(my.meth[typeIProbesRed,])
meth.3 = normalizeBetweenArrays(my.meth[typeIIProbes,])
unmeth.1 = normalizeBetweenArrays(my.unmeth[typeIProbesGrn,])
unmeth.2 = normalizeBetweenArrays(my.unmeth[typeIProbesRed,])
unmeth.3 = normalizeBetweenArrays(my.unmeth[typeIIProbes,])
#############################
Principal component analysis (PCA) on intensities of positive control probes (to remove batch effect)
Blood cell type proportion was estimated (to adjust cell type confounders)
PCA on intermediary residuals (to control global biological confounders)
General linear model of IDUs
2 a) PCA on intensities of control probes
PCA on the intensities of 237 positive control probes.
Prior-adjustment: Top PCs were correlated with some technical biases.
Post-adjustment: batch effect was significantly eliminated.
2 b) Blood cell type proportions estimation
Six blood cell sub-populations were estimated using the approach described by Houseman et al.
600 probes highly correlated with blood cell types were applied to estimate each cell type composition.
Minfi R package was used.
R code:
#############################
cellCounts <- estimateCellCounts(RGSet)
#############################
2 c) PCA on intermediary residuals
Regression model 1: adjusted for technical bias using Control probe PCA and some essential biological factors
GLM model:
Beta ~ Age + WBC_total + CD8T + CD4T + Gran + NK + Bcell + Mono + PC1-30ControlProbe
2 d) Final EWAS model
Regression model 2:
GLM model:
Beta ~ ivdused + Age + logVL+ WBC_total + CD8T + CD4T + Gran + NK + Bcell + Mono + PC1-30ControlProbe + PC1-5residual
PC1-30ControlProbe was used to control technical bias
PC1-5residual was used to control other global confounders
logVL: lg(HIV Viral Load); to control HIV VL
WBC_total, CD8T, CD4T, Gran, NK, Bcell, Mono: to control cell type
3 Clustering
3 a) hirarchical clustering
R library heatmap3 was used.
R code:
#############################
result <- heatmap3(dat,
distfun = distfunc,
hclustfun = hclustfunc,
ColSideCut = ColSideCut,
ColSideAnn = ColSideAnn,
ColSideFun = function\(x) \{
showAnn\(x)
},
ColSideWidth = ColSideWidth,
ColSideColors = ColSideColors,
RowAxisColors = RowAxisColors,
breaks = breaks,
l egendfun = legendfun,
col = cols,
verbose = T,
scale = scale,
showRowDendro = T,
showColDendro = T,
RowSideLabs = F,
ColSideLabs = F
)
#############################
Figure 6 hierarchical clustering
3 b) T-SNE visualization
R library Rtsne was used
R code:
#############################
train = dat
library(Rtsne)
set.seed(123456789)
tsne <- Rtsne(t(train), dims = 2, perplexity = 50, verbose = TRUE, max_iter = 2000, theta = 0)
#############################
4 Genome-wide differential DNA methylation region (DMR) analysis using bumphunter protocol.
First define a regression model very similar with EWAS final model (refre to 2 d), and then define gene clusters with R object gRatioSet. At last produce DMRs with bumphunter fucntions in minfi.
R code:
designMatrix_cov <- model.matrix(~ logVL_new + adhmed+dcq1pot+dcq2coke+dcq3stim+dcq4opio+alcohol+ivdused+AGEBL+RACECOMG+WBC_new+CD8T+CD4T+Gran+NK+Bcell+Mono+Control_Probe_PC1+Control_Probe_PC2+Control_Probe_PC3+Control_Probe_PC4+Control_Probe_PC5+Control_Probe_PC6+Control_Probe_PC7+Control_Probe_PC8+Control_Probe_PC9+Control_Probe_PC10+Control_Probe_PC11+Control_Probe_PC12+Control_Probe_PC13+Control_Probe_PC14+Control_Probe_PC15+Control_Probe_PC16+Control_Probe_PC17+Control_Probe_PC18+Control_Probe_PC19+Control_Probe_PC20+Control_Probe_PC21+Control_Probe_PC22+Control_Probe_PC23+Control_Probe_PC24+Control_Probe_PC25+Control_Probe_PC26+Control_Probe_PC27+Control_Probe_PC28+Control_Probe_PC29+Control_Probe_PC30+resiPC1+resiPC2+resiPC3+resiPC4+resiPC5+resiPC6+resiPC7+resiPC8+resiPC9+resiPC10, targets)
R code:
#############################
get_pos_chr_cluter_from_gRatio = function (cc_gRatioSet, maxGap=200000) {
annotation <- getAnnotation\(cc_gRatioSet);
chr = annotation$chr;
pos = annotation$pos;
cl <- clusterMaker\(chr, pos, maxGap = maxGap)
print\(table\(cl))
Indexes <- split\(seq_along\(cl), cl)
ret = list\(chr=chr, pos=pos, cl=cl, Indexes = Indexes)
}
cluster_info = get_pos_chr_cluter_from_gRatio(cc_gRatioSet, maxGap);
dmrs_cov.cl <- bumphunter(getBeta(cov_gRatioSet), design = designMatrix_cov, chr=cluster_info$chr, pos=cluster_info$pos, cluster=cluster_info$cl, cutoff = NULL, pickCutoff=T, maxGap = maxGap, B=perm_num, type="Beta", smooth=F, nullMethod="bootstrap")
#############################
5 Machine learning analysis
5 a) Support vector machine (SVM) algorithm and R package caret was used. The 386 samples in EWAS and 748 CpG sites were used as training set. A different set of 238 samples also from VACS was used as independent testing set. The training samples were divided into 5 equal number of subgroups with indexes of <16, 17–24, 25–34, 35–50, and >50. In the testing samples, high and low HIV frailty was defined as VACS index scores above 50 (the upper 20% quantile in 386 training samples) and below 16 (lower 20% quantile). We then tested prediction performance on subjects with high (VACS index >50 vs. ≤50) and low HIV frailty (VACS index <16 vs. ≥16), respectively.
5 b) 1000 times permutation test was conducted to study that if the 748 probes has a significant performance than random ones. AUROC was used in the analysis.
Figure 7 independent test, TP (true positive), FP (false positive), TN (true negative), FN (false negative) distribution
6 Pathway enrichment analysis
IPA was used on pathway enrichment analysis of DMP and DMR genes
Figure 8 Pathway enrichment analysis
The pipeline should produce the following results:
QC figures and normalized raw methylation data
EWAS results and significant probes
Machine learning results with using data of the significant CpG sites
Lehne B, et al. A coherent approach for analysis of the Illumina HumanMethylation450 BeadChip improves data quality and performance in epigenome-wide association studies. Genome Biol 16, 37 (2015).
Houseman EA, et al. DNA methylation arrays as surrogate measures of cell mixture distribution. BMC Bioinformatics 13, 86 (2012).
Jaffe AE, Irizarry RA. Accounting for cellular heterogeneity is critical in epigenome-wide association studies. Genome Biol 15, R31 (2014).
No conflicting financial interests to declare.
This protocol has been posted on Protocol Exchange, an open repository of community-contributed protocols sponsored by Nature Portfolio. These protocols are posted directly on the Protocol Exchange by authors and are made freely available to the scientific community for use and comment.
posted
You are reading this latest protocol version