Skip to main content
  • Research article
  • Open access
  • Published:

Stability SCAD: a powerful approach to detect interactions in large-scale genomic study

Abstract

Background

Evidence suggests that common complex diseases may be partially due to SNP-SNP interactions, but such detection is yet to be fully established in a high-dimensional small-sample (small-n-large-p) study. A number of penalized regression techniques are gaining popularity within the statistical community, and are now being applied to detect interactions. These techniques tend to be over-fitting, and are prone to false positives. The recently developed stability least absolute shrinkage and selection operator (SLASSO) has been used to control family-wise error rate, but often at the expense of power (and thus false negative results).

Results

Here, we propose an alternative stability selection procedure known as stability smoothly clipped absolute deviation (SSCAD). Briefly, this method applies a smoothly clipped absolute deviation (SCAD) algorithm to multiple sub-samples, and then identifies cluster ensemble of interactions across the sub-samples. The proposed method was compared with SLASSO and two kinds of traditional penalized methods by intensive simulation. The simulation revealed higher power and lower false discovery rate (FDR) with SSCAD. An analysis using the new method on the previously published GWAS of lung cancer confirmed all significant interactions identified with SLASSO, and identified two additional interactions not reported with SLASSO analysis.

Conclusions

Based on the results obtained in this study, SSCAD presents to be a powerful procedure for the detection of SNP-SNP interactions in large-scale genomic data.

Background

High-dimensional genomic data are becoming increasingly available to assist in the identification of genetic factors for complex diseases such as lung cancer. In particular, genome-wide association studies (GWAS) have implicated a variety of genetic variants in many diseases, while only a small fraction of phenotypic variation was explained by those. This suggests that multi-locus gene-gene or gene-environment interactions must be considered [1].

Gene-gene interactions could be detected using a variety of methods [2]. For example, multifactor dimensionality reduction (MDR, [3]) is a non-parametric and model-free method that does not require any assumption of genetic mode of inheritance. However, MDR is inefficient in handling large scale genetic datasets [4]. Penalized regression methods such as least absolute shrinkage and selection operator (LASSO) [5] and smoothly clipped absolute deviation (SCAD) [6] are also widely used for high-dimensional data. LASSO is a useful tool for detecting gene-gene interactions with a broad range of simulations [7]. SCAD penalty has an oracle property, and thus it is more consistent with the actual effects than LASSO [6]. The cross-validation is usually used for the choice of the amount of regularization in penalized regression methods (e.g., LASSO and SCAD), but it often includes too many noise variables. In an attempt to minimize such a problem, a modified LASSO penalized method, stability LASSO (SLASSO), has been proposed to unify optimal shrinkage and variable selection in GWAS ([8]). Stability selection controls false discovery rate and renders cross-validation practically unnecessary. Alexander and Lange (2011) claimed that SLASSO could accurately identify the most important regions of GWAS, but in a simulation study SLASSO offers less power than the simpler and less computationally intensive methods of marginal association testing [8].

It has been shown that the LASSO penalty could produce a bias even in the simple regression setting due to its linear increase of penalty on regression coefficients. To remedy this bias issue, a non-concave penalty such as SCAD penalty was proposed. SCAD has the so-called oracle property, meaning that, in the asymptotic sense, it performs as effectively as if an analyst had known in advance which coefficients were zero and which ones were nonzero [6]. SCAD is capable of achieving the sparse estimator in combination with smaller biases in linear regression than LASSO. Here, we propose a new stability selection procedure in combination with SCAD penalization (SSCAD). The new method was compared to SLASSO using systematic simulations and a published GWAS study.

Methods

Ethics statement

This collaborative study was approved by the institutional review boards of China Medical University, Tongji Medical College, Fudan University, Nanjing Medical University, and Guangzhou Medical College with written informed consent from all participants.

Penalized logistic regression for case-control GWAS

Let y i denote the disease status of the individual i ( i =1,…,n): 1 for case and 0 for control. The SNP of individual i, x ij , is formatted as the count of a particular allele (0, 1, or 2) where j = 1,…,m. The logistic model below includes SNP-SNP interaction terms:

y i Binominal 1 , π i , log π i 1 - π i = β 0 + j = 1 m β j x ij + j < k ξ jk x ij x ik , i = 1 , n ,
(1)

where x ij and x ij x ik are main effect and interaction features, respectively.

Penalized likelihood method makes the fitting of a logistic model with small-n-large-p computationally feasible. It also provides a mechanism for feature selection. L(θ) denotes the likelihood function of the above logistic model (1), where θ consists of those β and ξ. The penalized log-likelihood function takes the form

l p θ = - 2 log L θ + j p λ θ j ,
(2)

where p λ (•) is the penalty function characterized by a tuning parameter λ. The following penalty functions are used in LASSO and SCAD, respectively:

LASSO penalty : p λ θ j = λ | θ j | , SCAD penalty : p λ ' θ = λ 1 | θ | λ + - | θ | + a - 1 λ 1 | θ | > λ ,

where a is a fixed constant larger than 2, the notation (·)+ stands for the positive part, and 1(·) denotes the indicator function.

When the penalized logistic regression model is fitted, a predetermined number of the components of θ can be forced to zero by tuning λ to a certain value. For a specific variable, estimation of the coefficient is non-zero if the coefficient exceeds the threshold or equals to zero. Thus the selection of tuning parameter is a crucial step at the application of penalized likelihood. This is usually accomplished with cross validation. We used cross validation predictive area under the ROC curve to choose the appropriate tuning parameter.

LASSO and SCAD with cross-validated tuning parameter selection often lead to the inclusion of too many noise variables for high-dimensional data [9]. For variable selection in small-n-large-p genomic data, choosing the amount of regularization is more challenging than predicting where a cross-validation scheme can be used. A false variable in variable selection may lead to apparent association with a disease phenotype either through chance or correlation with the true variables. Studies using high-dimensional data often need to be validated due to false variables. Another practical issue here is reducing false variables while maintaining the power to detect relevant variables. To address this problem, Meinshausen and Bülmann [9] proposed a stability selection procedure that is relatively insensitive to the choice of tuning parameter [9].

In the current study, SCAD was used in variable selection in each sub-sample, and then stability selection was used to identify consensus ensemble of solutions.

Stability selection procedure

  1. a)

    Meinshausen and Bülmann (MB) stability selection methodology

Stability selection seeks to identify the non-zero entries S = {k:θ k  0} of a sparse parameter vector in above penalized logistic regression model (2). Assuming that the set I is a uniform random sub-sample of the index set {1,…,n}, the index set was used to subsample from the data to yield a subset Z(I). For the subset and a given regularization parameter λ Λ, penalized regression procedure was used to yield an estimate of θ k , i.e., θ ^ k λ I . Selection variable set was denoted as

S ^ λ I = k : θ ^ k λ 0 .

The conditional selection probability of the k-th covariate was defined as

Π ^ k λ = P k S ^ λ I | X , y .
(3)

The selection probabilities were naturally estimated by Monte Carlo method averaging over B times independent sub-sampling. Variables with high selection probabilities were retained, while those with low selection probabilities were discarded. For a cut-off π thr with 0 < π thr  < 1 and a set of regularization parameters Λ, the stable selection variables set was defined as

S ^ stable = k : max λ Λ Π ^ k λ π thr .
(4)

The basic idea of the stability selection is to repeat the feature selection process in many randomly perturbed subsamples (e.g., by bootstrapping the samples in the original data set), and to include features that are relevant to majority of the subsamples. The baseline of the stability selection procedure is explained below:

Given a cut-off, compute the stable selection variables set S ^ stable = k : max λ Λ Π ^ k λ π thr .

The threshold value π thr is a tuning parameter whose influence is very small. In principle, the tuning parameter of MB is based on the following theorem 1 of Meinshausen and Bülmann.

Theorem 1 (error control). Assuming that the distribution of 1 k S ^ λ , k N is exchangeable for λ Λ, and the original procedure is not worse than random guessing. Let q Λ be the average number of selected variables, q Λ = E | λ Λ S ^ λ I | , the expected number V of falsely selected variables is then bounded for π thr  (1/2, 1] by

E V 1 2 π thr - 1 q Λ 2 p .
(5)
  1. b)

    Improvements of the MB stability selection

In the current study (where pn), the primary goal was controlling the false discovery rate (FDR):

FDR = E V / S ^ stable E V / q Λ 1 2 π thr 1 q Λ p = 1 2 π thr 1 q Λ m + m m 1 / 2 .
(6)

An advantage of the stability selection is that the choice of the regularization parameters Λ does not have strong influence on the results, as long as λ is varied within a reasonable range [9]. To control FDR, we first chose a fixed regularization region Λ, and then chose the selective probability threshold π thr according to the above inequality (6).

We set a fixed regularization region as Λ = [λmin, λmax], which was decided by the number of selected variables q as follow: λmax corresponded to the variable that first entered the regularization path and λmin was chosen such that the first q variables that appeared in the regularization path, mathematically, λmin was chosen such that λ min λ λ max S ^ λ q . The value of q was chosen a priori to yield a non-trivial bound (see discussion on the paper by Meinshausen and Bühlmann [9]), i.e. q = O 2 π thr - 1 p ). The choice of q in stability selection does not have a strong impact on the FDR[9]. We used a conservative estimate of q (the square root of the number of predictors) in the discovery stage.

For the fixed regularization region, we applied the SCAD procedure to every subsample. q Λ = E | λ Λ S ^ λ I | was estimated via the Monte Carlo simulation averaging over B times independent sub-sampling. The threshold value π thr was solved while maintaining FDR ≤ α according to the expression (6) as

π thr = 1 + q Λ / 2 , if q Λ .
(7)

Unfortunately, given the nature of genetic data, the exact hypotheses required by the theorem of Meinshausen and Bülmann are unlikely to hold [9]. In particular, the exchangeability assumption of Theorem 1 about the indicator random variables 1 k S ^ λ , k N is questionable due to the correlations among the markers induced by linkage disequilibrium. We worried that the false positives of stability selection might be grossly wrong in our genetic data. So we adopted the method described in Alexander and Lange [8] to make a rough check on the false discovery rate of stability selection. We randomly permuted the phenotype vector y for all participants, firstly. We then performed the stability selection procedure on the permutation sample and obtained the selection probability of the variable corresponding to the maximum test statistic in the association analysis, and finally compared the selection probability with the cut-off calculated from the theorem of Meinshausen and Bülmann.

Data simulation

SSCAD selection procedure was compared with LASSO, SCAD, and SLASSO under a variety of interaction models.

Genotype simulation

HAPGEN (v2.2.0) program [10] was used to simulate genotype information. The simulation parameters for SNP frequencies and variance structure were extracted from HapMap3 JPT + CHB that includes SNPs located within ±20-kb of ABCC4 (ATP-binding cassette sub-family C member 4) at 13q31. The legend file for the SNP markers, and the fine scale recombination rate were downloaded from the HapMap website (http://hapmap.ncbi.nlm.nih.gov/downloads/index.html.en). After quality control, 327 common SNPs remained (with the exclusion criteria: missing data of SNPs > 5%, minor allele frequence < 5%, Hardy-Weinberg p-value < 10-4). The linkage disequilibrium (LD) pattern is shown in Figure 1.

Figure 1
figure 1

Pairwise r2 among the 327 SNPs across the gene ABCC4 . The color of each box signifies the value of r2 between SNPs alleles, with the black indicating strongest relationship between a pair of marks (1 = black, 0 = white).

Phenotype simulations

Genetic interaction model was applied for case/control phenotypes simulations. During the phenotype simulation, we took m =327 ( C m 2 = 53301 two-way interactions) and randomly selected causal SNPs from different haplotype blocks. The blocks were computed through Haploview v4.2 by standard expectation-maximization algorithm [11], which partitioned the region into segments of strong linkage disequilibrium (LD). A total of 26 blocks were generated with a minimum size of 2 markers and a maximum size of 64 markers. All the causal SNPs and SNP-SNP interactions were assumed to improve the risk (OR = 1.3, 1.4, and 1.5, respectively); wherein we let y i denote the phenotype value of subject i, which is obtained according to the logistic regression model (1).

We conducted simulations to evaluate selection performance of the LASSO, SCAD, SLASSO and SSCAD procedures under the following scenarios:

  1. (A).

    The interactive SNPs have no main effects:

    β j  = 0 for all j, and ξ jk  ≠ 0 for some randomly chosen j, k.

  2. (B).

    Only one SNP in the SNP-SNP interaction pair has a main effect:

    ξ jk  ≠ 0 and β j  ≠ 0 for some randomly chosen j, k.

  3. (C).

    Both interactive SNPs have main effects:

    ξ jk  ≠ 0, β j  ≠ 0 and β k  ≠ 0 for some randomly chosen j, k.

The odds ratio parameters are shown in Table 1. Since there are only a few etiological loci - only a few of the coefficients in the model are nonzero - the phenomenon is referred to as being sparse.

Table 1 Parameter settings of the different kinds of scenarios

For every simulation scenario of phenotype in Table 1, the phenotype y i was generated based on the simulated SNPs by HAPGEN 2 using the above-mentioned logistic regression model (1). We simulated the population with an equal number of cases and controls (n/2 = 10,000) with 200 replicate data sets, and then 1,000 cases and 1,000 controls were randomly sampled from the population to form one sample set. Next, we performed different variable selection methods for each sample set.

Simulated data analysis

R software (version 2.14.0, The R Foundation for Statistical Computing) was used to perform the simulation. The package “glmnet” and modified package “ncvreg” were used for LASSO and SCAD analysis, respectively. For stability selection, we chose B = 500 times independent sub-samples with a size of 500 cases and 500 controls from each 1000-1000 cases-controls sample set.

Application

The study subjects were from an ongoing two-center (Nanjing and Beijing, China) GWAS of lung cancer in China. At recruitment, written informed consent was obtained from each subject. The study was approved by the institutional review boards of each participating institution. The details of population and other related information were described previously [12]. A systematic quality control procedure was applied for both SNPs and individuals. SNPs were excluded if they did not map on autosomal chromosomes, with minor allele frequency < 0.05, with call rate < 95%, with p < 1 × 10-5 for Hardy-Weinberg equilibrium in combined samples of two studies or p < 1 × 10-4 in either the Nanjing or Beijing study samples. We removed samples with a call rate of < 95%, ambiguous gender, familial relationships, extreme heterozygosity rate, and outliers. Briefly, there were 1,473 cases and 1,962 controls in the Nanjing center, 858 cases and 1,115 controls in the Beijing center after quality control.

A multi-stage strategy is often used for detecting interactions on a genome-wide scale. The method proposed in the current study could not be directly applied to genome-wide scale SNPs data since it is too computationally intensive to exhaustively search for all SNP pairs. A filtering method could be helpful, as explained below using the achPathway pathway (a role of nicotinic acetylcholine receptors in the regulation of apoptosis). This pathway is one of the top pathways associated with lung cancer risk in the Han Chinese population. Several studies have shown that the nicotinic acetylcholine receptors can induce cell proliferation as well as angiogenesis [13]. The achPathway pathway includes the genes PIK3R1, PTK2B, PTK2, AKT1, PIK3CG, FASLG, MUSK, CHRNG, RAPSN, BAD, FOXO3, TERT, CHRNB1, PIK3CA, SRC and YWHAH. All SNPs are mapped into genes within 20 kb downstream or upstream. All together, there are 344 common SNPs. We conducted an exhaustive search ( C 344 2 = 58996 ) of two-way interaction in the pathway. Covariates including age, gender, pack-year of smoking, and the first two principal components, which have been proposed to sufficiently adjust for population stratification derived from EIGENSTRAT 3.0 [14], were adjusted in the stability selection procedure [12].

To increase confidence in the selection of significant interactions from tens of thousands of SNP pairs, interactions findings often need to be replicated in independent studies. We adopted a two-stage strategy in the current study. In the initial discovery stage, we used SLASSO and SSCAD to select significant SNP-SNP interactions using the data from the Nanjing center. In the replication stage, the findings in the initial step were validated using the data from the Beijing center with SLASSO and SSCAD. A slight variation was made to calibrate the significant threshold for the replication phase (i.e., we set the initial fixed number of variables in Beijing study as the number of selected variables in the discovery stage).

The SNP pairs were selected using the following criteria: (i) the interaction had the selection probability π l  ≥ πthr1 in the Nanjing study, while in the Beijing study the selection probability was π l  ≥ πthr2 (πthr1 and πthr2 are the significant thresholds of the Nanjing and Beijing studies, corresponding to the control of the FDR under 0.1); (ii) the Nanjing and Beijing centers both demonstrated identical direction of odds ratios for the two SNPs, with their interaction derived from penalized logistic regression.

Results

Result of simulation

We evaluated the performance of different variable selection procedures using four established statistical indexes, including the true positive rate (TPR):

TPR = TP TP + FN ,

the Mathhews correlation coefficient (MCC) [15]:

MCC = TP × TN - FP × FN TP + FP TP + FN TN + FP TN + FN ,

the estimated area under the ROC curves (AUC) [16]:

AUC = 1 t 0 p - t 0 u = 1 t 0 v = t 0 + 1 p I p ^ u > p ^ v + 1 2 I p ^ u = p ^ v ,

and the estimated false discovery rate (FDR,[17]):

FDR = FP FP + TP ,

where TP and TN stand for true positives and true negatives, FP and FN stand for false positives and false negatives, respectively. p ^ u is the selection probability of the u-th predictor and the first t0 variables are assumed to be true signals. The index TPR is known as sensitivity, whereas MCC is generally regarded as a balanced measure for both sensitivity and specificity, AUC summarizes overall prediction performance, and FDR is a criterion to measure and control the number of false positives for the class-skewed high-throughput data [18]. The indexes TPR, MCC and AUC are used to measure the power of detecting interactions, while FDR is primarily used to assess false positives of detection.

The simulation results of different procedures for the three kinds of scenarios are summarized in Tables 2, 3 and 4. All indexes are presented as average and standard error using 200 replications. The simulation results based on the Tables 2, 3 and 4 are described from the following two perspectives.

Table 2 Selection performance of different methods in different scenarios (OR = 1.5)
Table 3 Selection performance of different methods in different scenarios (OR = 1.4)
Table 4 Selection performance of different methods in different scenarios (OR = 1.3)

(I). SLASSO/SSCAD has lower false discovery rate than LASSO/SCAD while possessing similar AUC

It appears that SLASSO and SSCAD have lower FDR for identifying interactions in comparison to LASSO or SCAD. Contrary to LASSO and SCAD which generated unacceptably high FDR in all scenarios, both SLASSO and SSCAD controlled FDR at an acceptable level. In regards to predictive AUC, there was no difference in stability selection procedures that being its inclusion or exclusion. In other words, SLASSO or SSCAD achieved a higher specificity than other procedures despite the similar diagnostic accuracy of AUC.

(II). SSCAD has more robust power against SLASSO among different interaction models

Given an acceptable FDR level, we compared SSCAD with the SLASSO procedure in the detection of SNP-SNP interactions. SLASSO lost its ability to rapidly detect interactions as the reduction of the main effects from the scenarios C1/C2/C3 to scenarios B1/B2/B3 and A1/A2/A3. SSCAD, on the other hand, possessed robust detecting power under all scenarios. For the scenario A1/A2/A3, in which the model only included the SNP-SNP interaction without any main effects of SNPs, SSCAD was more powerful than SLASSO. An exemplification of this can be seen in scenario A1, in which the criteria of measuring the power of variable selection procedures echoed the trend: therein the TPR of SSCAD was 93.3%, while the one of SLASSO was only roughly 75.0%. Likewise, MCC and AUC were also both higher with SSCAD than with SLASSO.

The underlying interactions were better detected with SLASSO in the scenario C1 where the corresponding main effects were not too small (Table 2). SLASSO possessed slightly higher TPR, MCC and AUC than SSCAD in the scenario C1. SSCAD was more powerful than SLASSO in the scenario C2/C3 where the corresponding main effects ranged from small to moderate (Tables 3 and 4).

Generally speaking, the SCAD penalty has an edge over LASSO in selection features, namely those where the selective features are more consistent with their actual effects. The LASSO penalty may introduce more false interactions than the SCAD in the sparse high-dimensional models. Thus, SLASSO loses more true positives than SSCAD when controlling FDR estimation of stability selection at the desired level.

Overall, since the underlying interaction model is generally unknown, and a wide range of interaction models without marginal effects do exist [19], SSCAD is a valuable tool for discovering interactions without main effects and complement SLASSO in GWAS.

Result of application

Two SNP-SNP interactions were significant in both the discovery and replication phases by SLASSO (Table 5), and four SNP-SNP interactions were significant in both phases of SSCAD selection. SSCAD contained all significant interactions identified by SLASSO. When using SSCAD, the two pairs (rs7839119-rs4524871 and rs2736100-rs40318) were shown to have significant interactions in both the discovery and replication populations. In contrast, neither of two pairs was validated as significant in the replication phase with SLASSO.

Table 5 Empirical selection probability of significant SNP pairs by S LASSO and S SCAD under subsampling

For the SLASSO procedure, there were ten significant (π l  ≥ πthr1, FDR < 0.1) two-way SNP-SNP interactions in the Nanjing discovery study (Table 6). Among these ten SNP pairs, two were selected (π l  ≥ πthr2, FDR < 0.1) in the replication phase (Table 7). Both SNP-SNP interactions (rs7839119-rs12544802 and rs3781626-rs6018348) were verified in the replication phase. In an overall analysis that included discovery and replication datasets (5,408 subjects; 2,331 cases and 3,077 controls), the empirical selection probabilities of rs7839119-rs12544802 and rs3781626-rs6018348 interactions were 0.668 and 0.617, respectively; thus, indicating little statistical significance (π l  ≥ π thr , FDR < 0.1).

Table 6 Empirical selection probability of significant SNP pairs in Nanjing study by the S LASSO
Table 7 Empirical selection probability of significant SNP pairs in Beijing study by the S LASSO

Under the SSCAD procedure, all four significant SNP-SNP interactions (rs7839119-rs12544802, rs3781626-rs6018348, rs7839119-rs4524871 and rs2736100-rs40318) were successfully replicated (Tables 5, 8, and 9). The empirical selection probabilities of rs7839119-rs12544802, rs3781626-rs6018348, rs7839119-rs4524871 and rs2736100-rs40318 interactions in the overall analysis, which included all 5,408 subjects, were 0.801, 0.824, 0.980 and 0.977, respectively. In turn, these results indicate statistical significance (π l  ≥ π thr , FDR < 0.1).

Table 8 Empirical selection probability of significant SNP pairs in Nanjing study by the S SCAD
Table 9 Empirical selection probability of significant SNP pairs in Beijing study by the S SCAD

We also included the result of one permuted data set from the total 5,408 subjects combined. The selection probabilities of the SLASSO and SSCAD were 0.402 and 0.306, respectively. This corresponds to the maximum value of the test statistic for the permutation set. The cutoffs obtained from above inequality (6) for SLASSO and SSCAD with the significance (FDR < 0.1) were 0.593 and 0.560, respectively; thus, suggesting that the FDR calculated from the Meinshausen and Bülmann theorem is conservative. There appears to be little danger of selecting grossly inaccurate FDR when applying the Meinshausen and Bülmann theory.

Discussion

Identifying interactions among multiple SNPs is both statistically and computationally challenging in large-scale association studies. The challenges include high-dimensional problems, computational capability, multiple testing problems, and genetic heterogeneity [20]. Many stochastic and heuristic detecting epistasis methods [21] could be used to analyze GWAS dataset. Wang et al. used AntEpiSeeker, a two-stage ant colony optimization algorithm (ACO), to identify epistasis [22]. Wan et al. proposed SNPRuler [23] based on both predictive rule inference, and two-stage design. Boolean operation-based screening and testing (BOOST) [24] involves only Boolean values, and allows the use of fast logic operations to obtain contingency tables. TEAM [25] exploits properties of test statistics to mitigate multiple testing problems. To date, there appears to be no one method free from model sensitivity.

In addition to non-parametric and model-free methods, many LASSO-based penalized parametric methods provide the estimation of parameter as the dimensionality increases, even if the number of variables is greater than the sample size. The coefficients of those none disease-associated SNPs will be zero in the penalized multivariate regression model. Thus, detecting interactions is equivalent with the variable selection problem under the framework of regression analysis. A broad range of simulations has demonstrated that the penalized regression method is a useful tool for detecting gene-gene interactions. However, the regularization choice in penalized regression is usually made by cross-validation that maximizes predictive accuracy in finite samples; although it does not necessarily induce the correct sparseness pattern for variable selection [26]. In our simulations, cross-validation often leads to the inclusion of too many noise variables, and induces instability of variable selection for the ordinary penalized regression method, such as LASSO or SCAD. A major hurdle for studying interactions in GWAS is the lack of efficient algorithms that can map different forms of interactions while keeping FDR under control [27]. SLASSO introduces stability selection into traditional LASSO. The stability selection procedure combines selection algorithms for high dimensional problems by sub-sampling. SLASSO dramatically reduces the number of false discovery rate, and could accurately identify crucial regions of GWAS; however, it is overly conservative, and may miss some important regions.

SSCAD procedure increases the power of detecting the interactions while controlling FDR. It attempts to provide more true interactions, but less noise terms than SLASSO. The above advantage could be attributed to the fact that running the LASSO-penalized procedure within stability selection results in more false positives than SCAD for each random sub-sample. Thus, the interactions causing noise as well as true interactions in the region both satisfy the threshold condition π thr for selection. To control the number of falsely selected variables, the threshold must be very stringent. As a result, the SLASSO selection suffers a loss of power.

We analyzed a previously reported lung cancer dataset in Han Chinese, and confirmed significant interactions in the achPathway pathway, which supported the appropriate use of the proposed method. The observation of interactions between two closely located SNP pairs supports the hypothesis that some genetic variation in complex traits may hide in interactions between linked SNPs [28].

Application of the proposed procedure to GWAS data may ensure that the power of detection is reduced when over-stringent threshold π thr conditions exist for the much increased ratio of SNPs to samples. A good alternative to derive genome-wide significant threshold is permutation. Unfortunately, genome-wide permutation in real GWAS of interactions is computationally prohibitive for the SSCAD selection. Partial search strategies based on biological knowledge [29] or the filtering of unimportant SNPs prior to analysis [30] could be adopted to reduce excessive computing burdens in early stage of genome-wide scale. These strategies are also necessary for the proposed method.

Under our current approach, high-dimensional data were primarily managed with sparse models. High correlations (individual SNPs that have a variance inflation factor (VIF) > 2 with other markers) were excluded. The chip data were pruned, and then analyzed with regression model method using a sparse constraint. Many common diseases may be associated with many SNPs with small to moderate effects. In this situation, we are considering group penalized methods in another paper.

Conclusions

We developed a variable selection procedure (referred to as SSCAD selection). This procedure could control the FDR while maintaining the power to detect SNP-SNP interactions in association studies. In the pure interaction model, this procedure seems to overcome the conservativeness of SLASSO. The end result is that SSCAD, as a new technique in detecting interactions, can benefit the selection of SLASSO.

References

  1. Moore JH, Asselbergs FW, Williams SM: Bioinformatics challenges for genome-wide association studies. Bioinformatics. 2010, 26: 445-455. 10.1093/bioinformatics/btp713.

    Article  PubMed Central  PubMed  CAS  Google Scholar 

  2. Chen L, Yu G, Langefeld CD, Miller DJ, Guy RT, Raghuram J, Yuan X, Herrington DM, Wang Y: Comparative analysis of methods for detecting interacting loci. BMC Genomics. 2011, 12: 344-10.1186/1471-2164-12-344.

    Article  PubMed Central  PubMed  Google Scholar 

  3. Ritchie M, Hahn L, Roodi N, Bailey L, Dupont W, Parl F, Moore J: Multifactor-dimensionality reduction reveals high order interactions among estrogenmetabolism genes in sporadic breast cancer. Am J Hum Genet. 2001, 69: 138-147. 10.1086/321276.

    Article  PubMed Central  PubMed  CAS  Google Scholar 

  4. Yang C, Wan X, Yang Q, Xue H, Yu WC: Identifying main effects and epistatic interactions from large-scale snp data via adaptive group lasso. BMC Bioinforma. 2010, 11: SupplS18-

    Article  Google Scholar 

  5. Tibshirani R: Regression shrinkage and selection via the lasso. J R Statist Soc B. 1996, 58: 267-288.

    Google Scholar 

  6. Fan J, Li R: Variable selection via nonconcave penalized likelihood and its oracle properties. J Am Stat Assoc. 2001, 96: 1348-1360. 10.1198/016214501753382273.

    Article  Google Scholar 

  7. Winham S, Wang C, Motsinger-Reif AA: A comparison of multifactor dimensionality reduction and L1-penalized regression to identify gene-gene interactions in genetic association studies. Stat Appl Genet Mol Biol. 2011, 10 (1): 1-23.

    Google Scholar 

  8. Alexander D, Lange K: Stability selection for genome-wide association. Genet Epidemiol. 2011, 35: 722-728. 10.1002/gepi.20623.

    Article  PubMed  Google Scholar 

  9. Meinshausen N, Bülmann P: Stability selection. J Roy Statist Soc Ser B. 2010, 72: 417-473. 10.1111/j.1467-9868.2010.00740.x.

    Article  Google Scholar 

  10. Su Z, Marchini J, Donnelly P: Hapgen2: simulation of multiple disease snps. Bioinformatics. 2011, 27: 2304-2305. 10.1093/bioinformatics/btr341.

    Article  PubMed Central  PubMed  CAS  Google Scholar 

  11. Barrett JC, Fry B, Maller J, Daly MJ: Haploview: analysis and visualization of LD and haplotype maps. Bioinformatics. 2005, 21 (2): 263-265. 10.1093/bioinformatics/bth457.

    Article  PubMed  CAS  Google Scholar 

  12. Hu Z, Wu C, Shi Y, Guo H, Zhao X, Yin Z, Yang L, Dai J, Hu L, Tan W, Li Z, Deng Q, Wang J, Wu W, Jin G, Jiang Y, Yu D, Zhou G, Chen H, Guan P, Chen Y, Shu Y, Xu L, Liu X, Liu L, Xu P, Han B, Bai C, Zhao Y, Zhang H, et al: A genome-wide association study identifies two new lung cancer susceptibility loci at 13q12.12 and 22q12.2 in han chinese. Nat Genet. 2011, 43: 792-796. 10.1038/ng.875.

    Article  PubMed  CAS  Google Scholar 

  13. Bush WS, Moore JH: Chapter 11: Genome-wide association studies. PLoS Comput Biol. 2012, 8 (12): e1002822-10.1371/journal.pcbi.1002822.

    Article  PubMed Central  PubMed  CAS  Google Scholar 

  14. Price AL: Principal components analysis corrects for stratification in genome-wide association studies. Nat Genet. 2006, 38: 904-909. 10.1038/ng1847.

    Article  PubMed  CAS  Google Scholar 

  15. Baldi P, Brunak S, Chauvin Y, Andersen CAF, Nielsen H: Assessing the accuracy of prediction algorithms for classification:an overview. Bioinformatics. 2000, 16 (5): 412-424. 10.1093/bioinformatics/16.5.412.

    Article  PubMed  CAS  Google Scholar 

  16. Pepe MS: The Statistical Evaluation of Medical Tests for Classification and Prediction. 2003, New York: Oxford University Press

    Google Scholar 

  17. Benjamini Y, Hochberg Y: Controlling the false discovery rate: a practical and powerful approach to multiple testing. J R Stat Soc Ser B. 1995, 57 (1): 289-300.

    Google Scholar 

  18. Yu T: ROCS: Receiver Operating Characteristic Surface for class-skewed high-throughput data. Plos One. 2012, 7 (7): e40598-10.1371/journal.pone.0040598.

    Article  PubMed Central  PubMed  CAS  Google Scholar 

  19. Culverhouse R, Suarez B, Lin J, Reich T: A perspective on epistasis: limits of models displaying no main effect. Am J Hum Genet. 2002, 70: 461-471. 10.1086/338759.

    Article  PubMed Central  PubMed  Google Scholar 

  20. Cordell H: Detecting gene-gene interactions that underlie human diseases. Nat Rev Genet. 2009, 10 (6): 392-404. 10.1038/nrg2579.

    Article  PubMed Central  PubMed  CAS  Google Scholar 

  21. Shang J, Zhang J, Sun Y, Liu D, Ye D, Yin Y: Performance analysis of novel methods for detecting epistasis. BMC Bioinforma. 2011, 12 (1): 475-10.1186/1471-2105-12-475.

    Article  Google Scholar 

  22. Wang Y, Liu X, Robbins K, Rekaya R: AntEpiSeeker: detecting epistatic interactions for case-control studies using a two-stage ant colony optimization algorithm. BMC Res Notes. 2010, 3: 117-10.1186/1756-0500-3-117.

    Article  PubMed Central  PubMed  Google Scholar 

  23. Wan X, Yang C, Yang Q, Xue H, Tang N, Yu W: Predictive rule inference for epistatic interaction detection in genome-wide association studies. Bioinformatics. 2010, 26 (1): 30-37. 10.1093/bioinformatics/btp622.

    Article  PubMed  CAS  Google Scholar 

  24. Wan X, Yang C, Yang Q, Xue H, Fan X, Tang N, Yu W: BOOST: A fast approach to detecting gene-gene interactions in genome-wide case-control studies. Am J Hum Genet. 2010, 87 (3): 325-340. 10.1016/j.ajhg.2010.07.021.

    Article  PubMed Central  PubMed  CAS  Google Scholar 

  25. Zhang X, Huang S, Zou F, Wang W: TEAM: efficient two-locus epistasis tests in human genome-wide association study. Bioinformatics. 2010, 26 (12): i217-i227. 10.1093/bioinformatics/btq186.

    Article  PubMed Central  PubMed  CAS  Google Scholar 

  26. Leng C, Lin Y, Wahba G: A note on the lasso and related procedures in model selection. Stat Sinica. 2006, 16: 1273-1284.

    Google Scholar 

  27. Van Steen K: Travelling the world of gene–gene interactions. Brief Bioinform. 2012, 13 (1): 1-19. 10.1093/bib/bbr012.

    Article  Google Scholar 

  28. Haig D: Does heritability hide in epistasis between linked SNPs?. Eur J Hum Genet. 2011, 19: 123-

    Article  PubMed Central  PubMed  Google Scholar 

  29. Mea E: Using biological networks to search for interacting loci in genome-wide association studies. Eur J Hum Genet. 2009, 17: 1231-1240. 10.1038/ejhg.2009.15.

    Article  Google Scholar 

  30. Tea K-T: EPIBLASTER-fast exhaustive two-locus epistasis detection strategy using graphical processing units. Eur J Hum Genet. 2011, 19: 465-471. 10.1038/ejhg.2010.196.

    Article  Google Scholar 

Download references

Acknowledgments

The authors thank all of the study participants and research staff for their contributions and commitment to this study. This work was founded by the National Natural Science Foundation of China (grant numbers 81072389 to FC, 30901232 to YZ), key Grant of Natural Science Foundation of the Jiangsu Higher Education Institutions of China (11KJA330001 and 10KJA33034), the Priority Academic Program Development of Jiangsu Higher Education Institutions (PAPD), and the Research and the Innovation Project for College Graduates of Jiangsu Province (CXZZ12_0592). We also appreciate the editor and two anonymous reviewers for their valuable suggestions.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Feng Chen.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors’ contributions

JG performed the simulations, participated in the data analysis, and prepared for the manuscript. YZ participated in the design of simulations, and helped to draft the manuscript. YW helped to perform the simulations. RZ, YQ and PZ participated in the data analysis. CW, TW,DY,WT, ZH, DL and HS acquired the data. FC conceptualized the study. All authors read and approved the final manuscript.

Authors’ original submitted files for images

Below are the links to the authors’ original submitted files for images.

Authors’ original file for figure 1

Rights and permissions

Open Access This article is published under license to BioMed Central Ltd. This is an Open Access article is distributed under the terms of the Creative Commons Attribution License ( https://creativecommons.org/licenses/by/2.0 ), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited.

Reprints and permissions

About this article

Cite this article

Gou, J., Zhao, Y., Wei, Y. et al. Stability SCAD: a powerful approach to detect interactions in large-scale genomic study. BMC Bioinformatics 15, 62 (2014). https://doi.org/10.1186/1471-2105-15-62

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-15-62

Keywords