| Title: | Genome-Wide DNA Methylation Sites Screening by Use of Training and Testing Samples |
| Version: | 1.8 |
| Description: | A screening process utilizing training and testing samples to filter out uninformative DNA methylation sites. Surrogate variables (SVs) of DNA methylation are included in the filtering process to explain unknown factor effects. This package also provides two screening functions for screening high-dimensional predictors when the events are rare. The firth method is called 'Rare-Screening' which employs a repeated random sampling with replacement and using linear modeling with Bayes adjustment. The Second method is called 'Firth-ttScreening' which uses 'ttScreening' method with additional Firth correction term in the maximum likelihood for the logistic regression model. These methods handle the high-dimensionality and low event rates. |
| License: | Artistic-2.0 |
| Encoding: | UTF-8 |
| RoxygenNote: | 7.3.3 |
| Depends: | matrixStats,sva,limma |
| Imports: | graphics,stats,corpcor,simsalapar,MASS,brglm2 |
| Suggests: | mvtnorm |
| NeedsCompilation: | no |
| Packaged: | 2026-01-30 17:32:17 UTC; maray |
| Author: | Meredith Ray [aut, cre], Mohammad Nahian Ferdous Abrar [aut], Yu Jiang [aut], Xin Tong [aut], Hongmei Zhang [aut] |
| Maintainer: | Meredith Ray <maray@memphis.edu> |
| Repository: | CRAN |
| Date/Publication: | 2026-01-30 17:50:02 UTC |
Genome-Wide DNA Methylation Sites Screening by Use of Training and Testing Samples
Description
ttScreening is a screening process to filter out non-informative DNA methylation sites by applying (ordinary or robust) linear regressions to training data, and the results are further examined using testing samples. Surrogate variables are included to account for unknown factors. This package also contains two additional functions, Rare_Screening and firth_screening, for predictor screening in high-dimensional settings when the outcome is binary and is rare (binary with low prevalence). These methods were developed to handle challenges while screening predictors such as separation and small event counts and high-dimensionality, which are common in genomic and epigenomic studies.
Details
| Package: | ttScreening |
| Type: | Package |
| Version: | 1.8 |
| Date: | 2025-12-10 |
| License: | Artistic-2.0 |
This package utilizes training and testing samples to filter out uninformative DNA methylation sites for continuous and rare binary outcomes. Surrogate variables (SVs) of DNA methylation are included in the filtering process to explain unknown factor effects.
Author(s)
Meredith Ray, Mohammad Abrar, Yu Jiang, Xin Tong, Hongmei Zhang
Maintainer: Meredith Ray <maray@memphis.edu>
References
Ray MA, Tong X, Lockett GA, Zhang H, and Karmaus WJJ. (2016) “An Efficient Approach to Screening Epigenome-Wide Data”, BioMed Research International.
Leek JT and Storey JD. (2007) “Capturing heterogeneity in gene expression studies by ‘Surrogate Variable Analysis’.” PLoS Genetics, 3: e161.
Rare_Screening: resampling-based screening with limma
Description
Rare_Screening: a resampling-based method that repeatedly samples cases and controls with replacement and applies bayes moderated linear modeling (limma) to identify predictors that are consistently significant. The function runs a rare-event resampling procedure on user provided data and returns the selected predictors along with iteration-wise selection counts.
Dr. Abrar maintains and is the author of this functions, for questions contact him at abrar0708@gmail.com.
Usage
Rare_Screening(predictor_list, Outcome, iteration, cut)
Arguments
predictor_list |
Numeric matrix of size n x p (rows = subjects, columns = predictors). Column names are treated as predictor IDs; if missing, they will be generated. |
Outcome |
Integer or logical vector of length n with values in {0,1}. |
iteration |
Integer, number of bootstrap iterations (e.g., 100). |
cut |
Integer, selection count threshold (e.g., 70) used to define final selection. |
Value
A list with:
-
final_selection: character vector of selected predictor IDs (selection count >= cut) -
counts: integer vector of selection counts for all predictors (names = predictors) -
sel_mat: p x iteration matrix of 0/1 selections per iteration -
selected: integer indices of the predictors that metcut
Examples
## Not run:
# predictor_list: n x p matrix; Outcome: 0/1 vector of length n
res <- Rare_Screening(predictor_list, Outcome, iteration = 100, cut = 70)
head(res$final_selection)
## End(Not run)
ttScreening with Firth bias-reduced logistic regression + multiple testing
Description
firth_screening: a two-stage approach combining ttScreening with Firth’s bias-reduced logistic regression. This method is designed to handle small sample sizes and rare outcomes by reducing bias in logistic regression coefficients.
Two-stage screening: (1) Pre-screen each predictor with bias-reduced logistic regression (brglm2). (2) For predictors passing pre-screen, run repeated train/test splits and count how often the test p-value < 0.05. Also report Bonferroni and FDR sets from the pre-screen p-values.
Dr. Abrar maintains and is the author of this functions, for questions contact him at abrar0708@gmail.com.
Usage
firth_screening(
predictor_list,
Outcome,
iteration,
train_frac = 0.67,
alpha = 0.05,
firth_count_threshold = 50,
verbose = TRUE
)
Arguments
predictor_list |
Numeric matrix of dimension n x p (rows = subjects, cols = predictors). Column names are treated as predictor IDs; if missing, they will be generated. |
Outcome |
Integer or logical vector of length n with values in {0,1}. |
iteration |
Integer, number of train/test resampling iterations (e.g., 100). |
train_frac |
Numeric in (0,1); fraction of each class used for training (default 0.67). |
alpha |
Numeric in (0,1) p-value cutoff used inside splits (default 0.05). |
firth_count_threshold |
Integer, minimum number of "successes" to call a predictor selected by the ttScreening path (default 50). |
verbose |
Logical; if TRUE prints a short summary (default TRUE). |
Value
A list with:
-
firth_tt: character vector of predictor IDs selected by repeated ttScreening (count>= firth_count_threshold) -
Bonferroni: character vector selected by Bonferroni-adjusted p < 0.05 (pre-screen) -
FDR: character vector selected by FDR-adjusted p < 0.05 (pre-screen) -
prescreen_p: named numeric vector of pre-screen p-values -
counts: named integer vector of ttScreening success counts
Examples
## Not run:
res <- firth_screening(
predictor_list, Outcome,
iteration = 100, train_frac = 0.67, alpha = 0.05, firth_count_threshold = 50
)
length(res$firth_tt); head(res$firth_tt)
## End(Not run)
Adjusted irwsva.build which builds surrogate variables from gene expression data
Description
This function is directly modified from the original irwsva.build() in the SVA package. It was noticed that under certain circumstances a subscript out of bounds error would occur while running the SVA function. Therefore, this modified code has a single line altered that conditionally uses the generic singular decomposition, svd(), instead of fast singular decomposition, fast.svd().
Usage
irwsva.build2(dat, mod, mod0 = NULL, n.sv, B = 5)
Arguments
dat |
A m CpG sites by n subjects matrix of methylation data. |
mod |
A n by k model matrix corresponding to the primary model fit (see model.matrix) |
mod0 |
A n by k0 model matrix corresponding to the null model to be compared to mod. |
n.sv |
The number of surrogate variables to construct. |
B |
The number of iterations of the algorithm to perform. |
Details
See http://www.bioconductor.org/packages/release/bioc/manuals/sva/man/sva.pdf
Value
sv |
A n by n.sv matrix where each column is a distinct surrogate variable. |
pprob.gam |
A vector with the posterior probability estimates that each row is affected by dependence. |
pprob.b |
A vector with the posterior probabiliity estimates that each row is affected by the variables in mod, but not in mod0. |
n.sv |
The number of suggorate variables estimated. |
Note
sva Vignette http://www.biostat.jhsph.edu/~jleek/sva/
Author(s)
Original irwsva.build: Jeffrey T. Leek <jleek@jhsph.edu>, John Storey jstorey@princeton.edu
References
Original sva: Leek JT and Storey JD. (2008) A general framework for multiple testing dependence.Proceedings of the National Academy of Sciences, 105: 18718-18723.
Leek JT and Storey JD. (2007) Capturing heterogeneity in gene expression studies by surrogate variable analysis. PLoS Genetics, 3: e161.
Adjusted num.sv which estimates the number of important surrogate variables from a gene expression data set.
Description
This function is directly modified from the orginal num.sv() in the SVA package on Bioconductor. This function has the tolerance level in the fast.svd() function set back to its orginal default instead of 0.
Usage
num.sv2(dat, mod, method = c("be", "leek"), vfilter = NULL,
B = 20, sv.sig = 0.1, seed = NULL)
Arguments
dat |
A m genes by n arrays matrix of expression data. |
mod |
A n by k model matrix corresponding to the primary model fit (see model.matrix). |
method |
The method to use for estimating surrogate variables, for now there is only one option (based ib Buja and Eyuboglu 1992). |
vfilter |
The number of most variable genes to use when building SVs, must be between 100 and m. |
B |
The number of null iterations to perform. Only used when method="be". |
sv.sig |
The significance cutoff for eigengenes. Only used when method="be". |
seed |
A numeric seed for reproducible results. Optional, only used when method="be". |
Details
See http://www.bioconductor.org/packages/release/bioc/manuals/sva/man/sva.pdf
Value
n.sv |
The number of significant surrogate variables |
Note
sva Vignette http://www.biostat.jhsph.edu/~jleek/sva/
Author(s)
Original num.sv: Jeffrey T. Leek <jleek@jhsph.edu>, John Storey jstorey@princeton.edu
References
Original sva: Leek JT and Storey JD. (2008) A general framework for multiple testing dependence.Proceedings of the National Academy of Sciences, 105: 18718-18723.
Leek JT and Storey JD. (2007) Capturing heterogeneity in gene expression studies by surrogate variable analysis. PLoS Genetics, 3: e161.
The adjusted sva code using irwsva.build2
Description
This function is the modified SVA function in which it uses the irwsva.build2 function rather than the irwsva.build function to build the surrogate variables. Thus, only a single line has been altered from the original surrogate variable anaysis function.
Usage
sva2(dat, mod, mod0 = NULL, n.sv = NULL, method = c("irw", "two-step"),
vfilter = NULL, B = 5, numSVmethod = "be")
Arguments
dat |
An m by n (m cpg sites by n subjects) matrix of methylation data. |
mod |
A n by k model matrix corresponding to the primary model fit (see model.matrix). |
mod0 |
A n by k0 model matrix corresponding to the null model to be compared to mod. |
n.sv |
Optional. The number of surrogate variables to estimate, can be estimated using the num.sv function. |
method |
Choose between the iteratively re-weighted or two-step surrogate variable estimation algorithms. |
vfilter |
The number of most variable CpG sites to use when building SVs, must be between 100 and m. |
B |
The number of iterations of the algorithm to perform. |
numSVmethod |
The method for determining the number of surrogate variables to use. |
Details
See http://www.bioconductor.org/packages/release/bioc/manuals/sva/man/sva.pdf
Value
sv |
A n by n.sv matrix where each column is a distinct surrogate variable. |
pprob.gam |
A vector with the posterior probability estimates that each row is affected by dependence. |
pprob.b |
A vector with the posterior probabiliity estimates that each row is affected by the variables in mod, but not in mod0. |
n.sv |
The number of suggorate variables estimated. |
Note
sva Vignette http://www.biostat.jhsph.edu/~jleek/sva/
Author(s)
Original sva: Jeffrey T. Leek <jleek@jhsph.edu>, John Storey jstorey@princeton.edu
References
Original sva: Leek JT and Storey JD. (2008) A general framework for multiple testing dependence. Proceedings of the National Academy of Sciences, 105: 18718-18723.
Leek JT and Storey JD. (2007) Capturing heterogeneity in gene expression studies by surrogate variable analysis. PLoS Genetics, 3: e161.
A screening process built upon training and testing samples
Description
A screening process to filter out non-informative DNA methylation sites by applying (ordinary or robust) linear regressions to training data, and the results are further examined using testing samples. Surrogate variables are included to account for unknown factors.
Usage
ttScreening(y = y, formula, imp.var, data, B.values=FALSE,iterations = 100,
sva.method = c("two-step", "irw"), cv.cutoff = 50, n.sv = NULL,
train.alpha = 0.05, test.alpha = 0.1, FDR.alpha = 0.05, Bon.alpha = 0.05,
percent = (2/3),linear = c("robust", "ls"), vfilter = NULL, B = 5,
numSVmethod = "be", rowname = NULL, maxit=20)
Arguments
y |
Data matrix of DNA methylation measures (m by n, m CpG sites and n subjects). Each column represents DNA methylation measures of all CpG sites for one subject. |
formula |
An object of class |
imp.var |
A vector indicating the location of the term(s) in the formula option on which the selection of CpG sites are made. Interactions are considered a single term. For example, suppose the right-hand side of the equation is: x + z + x:z. If the decision of selecting a CpG site is based on one single term, e.g., the significance of interaction effect, then imp.var is set as the location of that term, e.g., imp.var=3 (the third term). If the decision is desired to base on all the three terms, then imp.var=c(1,2,3). |
data |
Data frame created from model.frame. Also is the data frame containing the variables defined in formula. |
B.values |
Logical, TRUE if indicating the methylation is measured as beta values, FALSE if methylation is measured as M-values. The default is FALSE. |
iterations |
Number of loops for the training/testing (TT) procedure. The default is 100. |
sva.method |
Option of the two surrogate variable estimation algorithms, the iteratively re-weighted, |
cv.cutoff |
The minimum frequency required for a DNA methylation site to be treated as an informative site. After "iterations" iterations, the frequency of each DNA methylation being selected out of |
n.sv |
Number of surrogate variables. If NULL, the number of surrogate variables will be determined based on the data. The default is NULL. |
train.alpha |
Significance level for training samples. The default is 0.05. |
test.alpha |
Significance level for testing samples. The default is 0.05. |
FDR.alpha |
False discovery rate. The default is 0.05. This is to fit the need of selecting variables based on FDR. |
Bon.alpha |
Overall significance level by use of the Bonferroni method for mulitple testing correction. The default is 0.05. This is to fit the need of selecting variables based on the Bonferroni multiple testing correction. |
percent |
Proportion of the full sample to be used for training. The default is 2/3. |
linear |
Choice of linear regression methods, |
vfilter |
The number of most variable CpG sites to use when building SVs, must be between 100 and the number of genes; Must be NULL or numeric (> 0), The default is NULL. |
B |
Number of iterations in generating surrogate variables. The default is 5. |
numSVmethod |
The method for determining the number of surrogate variables to use. The default is |
rowname |
Optional, NULL or |
maxit |
Optional, controls the number of iterations for linear regression estimation methods. The default is 20. |
Details
Value
sub.remove |
Denotes which subjects (based on order) were removed due to incomplete or missing data within the prediction variables defined in the formula arguement. |
train.cpg |
Number of DNA methylation sites selected after the training step of each loop. |
test.cpg |
Number of DNA methylation sites selected after the testing step of each loop. |
selection |
Indicator matrix for the TT method after the testing step. The number of rows is the number of methylation sites, and the number of columns is the number of iterations. An entry of 1 indiates the selection of a site, and 0 otherwise. |
pvalue.matrix |
Matrix of p-values of the selected DNA methylation sites after the testing step. The number of rows is the number of methylation sites and the number of columns is the number of iterations. For methylation sites not selected, NA is listed. |
TT.cpg |
Final list of the DNA methylation sites by their original rownames selected from the TT method. |
FDR.cpg |
Final list of the DNA methylation sites by their original rownames selected from the FDR method. |
Bon.cpg |
Final list of the DNA methylation sites by their original rownames selected from the Bonferroni method. |
SV.output |
Data frame containing the estimated surrogate variables. |
TT.output |
Data frame containing the list of DNA methylation sites selected from the TT method and the respective coefficients and pvalues for the variables and SVs. |
FDR.output |
Data frame containing the list of DNA methylation sites selected from the FDR method and the respective coefficients and pvalues for the variables and SVs. |
Bon.output |
Data frame containing the list of DNA methylation sites selected from the Bonferroni method and the respective coefficients and pvalues for the variables and SVs. |
References
Meredith Ray, Xin Tong, Hongmei Zhang, and Wilfred Karmaus. (2014) "DNA methylation sites screening with surrogate variables", unpublished manuscript.
Leek JT and Storey JD. (2007) "Capturing heterogeneity in gene expression studies by ‘Surrogate Variable Analysis’." PLoS Genetics, 3: e161.
Examples
## Not run:
library(mvtnorm)
nsub=600
imp=100
num=2000
set.seed(1)
x1= rnorm(nsub,1,1)
size1<-rmultinom(1,nsub,c(0.15,0.25,0.25,0.35))
x2= matrix(sample(c(rep(0,size1[1,]),
rep(1,size1[2,]),
rep(2,size1[3,]),
rep(3,size1[4,])),replace=F),byrow=250,ncol=1)
sur1<-rnorm(nsub,0,5)
sur2<-rnorm(nsub,3,1)
sur3<-rnorm(nsub,0,1)
sur4<-rnorm(nsub,2,4)
sur5<-rnorm(nsub,0,3)
sigma1<-matrix(0,nrow=num,ncol=num)
diag(sigma1)<-1.5
beta0<-0.5
beta1<-0.3
beta2<-0.3
beta3<-0.3
sbeta1<-rnorm(1,0.5,0.01)
sbeta2<-rnorm(1,0.5,0.01)
sbeta3<-rnorm(1,0.5,0.01)
sbeta4<-rnorm(1,0.5,0.01)
sbeta5<-rnorm(1,0.5,0.01)
#beta matrix#
beta<-as.matrix(cbind(beta0,beta1,beta2,beta3,sbeta1,sbeta2,sbeta3,sbeta4,sbeta5))
beta.no2<-as.matrix(cbind(beta0,beta1,beta3,sbeta1,sbeta2,sbeta3,sbeta4,sbeta5))
beta.sur<-as.matrix(cbind(sbeta1,sbeta2,sbeta3,sbeta4,sbeta5))
#design matrix#
X<-as.matrix(cbind(rep(1,length(x1)),x1,x2,x1*x2,sur1,sur2,sur3,sur4,sur5))
X.no2<-as.matrix(cbind(rep(1,length(x1)),x1,x1*x2,sur1,sur2,sur3,sur4,sur5))
X.sur<-as.matrix(cbind(sur1,sur2,sur3,sur4,sur5))
#mu matrix#
imp1.mu<-matrix(rep(X%*%t(beta),9),nrow=nsub,ncol=(imp*0.9))
imp2.mu<-matrix(rep(X.no2%*%t(beta.no2),1),nrow=nsub,ncol=(imp*0.1))
noimp.mu<-matrix(rep(X.sur%*%t(beta.sur),num-imp),nrow=nsub,ncol=num-imp)
mu.matrix=cbind(imp1.mu, imp2.mu, noimp.mu)
error<-rmvnorm(nsub,mean=rep(0,num),sigma=sigma1,method = "chol")
y<-t(mu.matrix+error)
runs<-ttScreening(y=y,formula=~x1+x2+x1:x2,imp.var=3,data=data.frame(x1,x2),sva.method="two-step",
B.values=FALSE,iterations=100,cv.cutoff=50,n.sv=NULL,train.alpha=0.05,
test.alpha=0.05,FDR.alpha=0.05,Bon.alpha=0.05,percent=(2/3),linear= "ls",
vfilter = NULL, B = 5, numSVmethod = "be",rowname=NULL,maxit=20)
runs$TT.output
runs$FDR.output
runs$Bon.output
## End(Not run)