Skip to main content
PLOS ONE logoLink to PLOS ONE
. 2020 Nov 30;15(11):e0242927. doi: 10.1371/journal.pone.0242927

Novel methods for epistasis detection in genome-wide association studies

Lotfi Slim 1,2,*, Clément Chatelain 2, Chloé-Agathe Azencott 1,3, Jean-Philippe Vert 1,4
Editor: Jiang Gui5
PMCID: PMC7703915  PMID: 33253293

Abstract

More and more genome-wide association studies are being designed to uncover the full genetic basis of common diseases. Nonetheless, the resulting loci are often insufficient to fully recover the observed heritability. Epistasis, or gene-gene interaction, is one of many hypotheses put forward to explain this missing heritability. In the present work, we propose epiGWAS, a new approach for epistasis detection that identifies interactions between a target SNP and the rest of the genome. This contrasts with the classical strategy of epistasis detection through exhaustive pairwise SNP testing. We draw inspiration from causal inference in randomized clinical trials, which allows us to take into account linkage disequilibrium. EpiGWAS encompasses several methods, which we compare to state-of-the-art techniques for epistasis detection on simulated and real data. The promising results demonstrate empirically the benefits of EpiGWAS to identify pairwise interactions.

Introduction

Decrease in sequencing cost has widened the scope of genome-wide association studies (GWAS). Large cohorts are now built for an ever growing number of diseases. In common ones, the disease risk depends on a large number of genes connected through complex interaction networks. The classical approach and still widespread methodology in GWAS is to implement univariate association tests between each single nucleotide polymorphism (SNP) and the phenotype of interest. Such an approach is limited for common diseases, where the interactions between distant genes, or epistasis, need to be taken into account. For instance, several epistatic mechanisms have been highlighted in the onset of Alzheimer’s disease [1]. Most notably, the interaction between the two genes BACE1 and APOE4 was found to be significant on four distinct datasets. Moreover, at least two epistatic interactions were also reported for multiple sclerosis [2, 3].

Several strategies [4, 5] have been developed for the detection of statistical epistasis. Many of them consist in exhaustive SNP-SNP interaction testing, followed by corrections for multiple hypothesis testing using procedures such as Bonferroni correction [6] or the Benjamini-Hochberg [7] (BH) procedure. For all procedures, the correction comes at the cost of poor statistical power [8]. For high-order interactions, the loss in statistical power is aggravated by the large number of SNP tuples to consider. Moreover, exhaustive testing for high-order interactions is also accompanied by an increase in computational complexity. For increased speed, the current state-of-the-art BOOST [9] and its GPU-derivative [10] add a preliminary screening to filter non-significant interactions. Another fast interaction search algorithm in the high-dimensional setting is the xyz-algorithm [11].

By contrast, instead of constructing exhaustive models, we propose to focus on the interactions that involve a given variant, that we refer to as the target in what follows. The target is a formerly identified SNP that can be extracted from top hits in previous GWAS, causal genes, or experiments. The main rationale behind this approach is to leverage the established dependency between the target and the phenotype for a better detection of epistatic phenomena: a lower number of interactions has to be studied with the additional guarantee that the target affects the phenotype in question. In addition, focusing on interactions with a single variant allows us to model the interaction of this variant with all other SNPs in the genome at once, rather than pair of SNPs by pair of SNPs.

For the purpose of epistasis detection, the pure synergistic effects of the target with other variants must be decoupled from the marginal effects of the target and the other variants. A failure to address this issue can alter the results. One way to do so is to use an 1-penalized regression model [12] with both marginal effect and quadratic interaction terms. If only one target SNP is investigated, generating as many quadratic interaction terms as remaining SNPs in the genome, the number of coefficients in this regression is doubled compared to a linear model with only marginal effects, rather than squared if all pairwise interaction terms were to be considered. However, this is still too many in a high-dimensional context such as GWAS. To improve the inference of the interaction coefficients, Bien et al. [13] introduced hierNET, a LASSO with hierarchy constraints between marginal and interactions terms. However, this approach does not scale to more than a hundred variables and is therefore inapplicable to GWAS data.

We turn instead towards methods developed in the context of randomized controlled trials, which aim at detecting synergies between a treatment (rather than a target SNP) and a set of covariates (rather than other SNPs) towards an outcome (rather than a phenotype). We draw on this analogy to propose two families of methods for epistasis detection. First, modified outcome approaches are inspired by the work of Tian et al. [14]. Here we construct a modified phenotype from the phenotype and all SNPs, in such a way that the SNPs in epistasis with the target form the support of a sparse linear regression between this modified phenotype and the non-target SNPs. Second, outcome weighted learning approaches are inspired by the work of Zhao et al. [15]. Here the SNPs in epistasis with the target form the support of a weighted sparse linear regression between the phenotype and the non-target SNPs, with samples weighted according to the phenotype and the target SNP.

A major difference between our setting and that of randomized controlled trials is the fact that, where they assume that the treatment is independent from the covariates, we cannot assume independence between the target SNP and the rest of the genome. Indeed, although recombination can be expected to break down non-random associations between alleles at several loci, such associations exist, and are referred to as linkage disequilibrium [16]. To account for this dependence, we introduce the equivalent of propensity scores (that is to say, the probability of treatment given the covariates [17]) in the modified outcome and outcome weighted learning approaches. In addition, the high dimensionality of the data leads us to use stability selection [18, 19] to select the regularization parameter of the 1-penalized regressions.

In summary, we develop a new framework to study epistasis by solely focusing on the synergies with a predetermined target. By proceeding this way, our methods improve the recovery of interacting SNPs compared to standard methods like GBOOST or a LASSO with interaction terms. We demonstrate the performance of our methods against both of them for several types of disease models. We also conduct a case study on a real GWAS dataset of type II diabetes to demonstrate the scalability of our methods and to investigate the resulting differences between them.

Materials and methods

Setting and notations

We jointly model genotypes and phenotypes as a triplet of random variables (X, A, Y) with distribution P, where Y is a discrete (e.g. in case-control studies) or continuous phenotype, X = (X(1), ⋯, X(p)) ∈ {0, 1, 2}p represents a genotype with p SNPs, and A is the (p + 1)-th target SNP of interest. The reason why we split the p + 1 SNPs into X and A is that our goal is to detect interactions involving A and other SNPs in X. Several selection strategies are possible for the anchor target A: eQTL SNPs for genes with proven effect on the phenotype Y, deleterious splicing variants, or among significant SNPs in previous GWAS. In classical GWAS, the SNPs are identified on the basis of the significance of their main effects. A SNP with interaction effects only can then be overlooked. To detect such SNPs, we can use association measures such as distance correlation [20] and mutual information [21] which can better capture second-order interaction effects. Alternatively, for the genotype X, we can choose the rest of the genome (the whole genome except the target A) or a given set of SNPs. The SNP set may correspond to a genomic region of interest e.g. gene, promoter region, or a pathway.

We restrict ourselves to a binary encoding of A in {−1, +1}, which allows us to study both recessive and dominant phenotypes, depending on how we binarize the SNP represented in A. For instance, to model dominant effects, we respectively map {0} and {1, 2} to {−1} and {+1}. We also introduce a second binarized version of the target SNP A taking values in {0, 1} by letting A˜=(A+1)/2. SNP binarization is a common procedure in GWAS in particular for the study of epistasis. Prabhu and Pe’er [22] and Llinares-López [23] implement binarized genotypes, while Achlioptas et al. [24] use locality-sensitive hashing (LSH) to transform the original genotypes into binary vectors. The question is moot in doubled haploid organisms, where the SNPs are homozygous only.

The target SNP A being symmetric and binary, it is always possible to decompose the genotype and phenotype relationship as:

Y=μ(X)+δ(X)·A+ϵ, (1)

where ϵ is a zero mean random variable and,

{μ(X)=12[E(Y|A=+1,X)+E(Y|A=-1,X)],δ(X)=12[E(Y|A=+1,X)-E(Y|A=-1,X)]. (2)

If we further decompose δ(X) = δ0 + δ1(X) with E(δ1(X))=0, then δ0 represents the main effect of A, and δ1(X) the synergistic effects between A and all SNPs in X. In the context of genomic data, we can interpret these synergies as pure epistatic effects: the main effects are accounted for by μ(X) and δ0. Furthermore, if δ1(X) is sparse, meaning that it only depends on a subset of elements of X, referred to as the support of δ1(X), then the SNPs in this support are the ones interacting with A. In other words, searching for epistatic interactions between A and SNPs in X amounts to searching for the support of δ.

A GWAS dataset is a set of n triplets (Xi, Ai, Yi)i=1,…,n, which we model as independent random variables identically distributed according to P. To estimate the support of δ(X) from a GWAS dataset, we propose several models based on sparse regression. The common thread between them is the use of propensity scores to estimate δ(X) and its support without estimating μ(X). We borrow the notion of propensity score from the causal inference literature, where we are interested in estimating the effect of a treatment on individuals characterized by covariates x. In that context, the propensity score e(x) is defined as the conditional probability of being treated for an individual with covariates x. The propensity score can be used to compensate the differences in covariates between the two groups in observational studies, where, by contrast with randomized controlled trials, investigators have no control over the treatment assignment [25]. In our case, by analogy, we define the propensity score e(x) for a configuration of SNPs X = x as the probability that the target SNP A is equal to 1, i.e., e(x) = P(A = 1|X = x). This score allows us to model linkage disequilibrium (LD) between A and other nearby SNPs within X. Based on this notion of propensity score, the first family of methods we propose falls under the modified outcome banner [14]. In these models, an outcome that combines the phenotype Y with the target SNP A and the propensity score e(X) is fit linearly to the genomic covariates X. We propose several variants of this approach, which differ in their control of estimation errors. Our second proposal is a case-only method based on the framework of outcome weighted learning [15]. In this model, which is a weighted binary classification problem, the outcome is the target SNP A, the covariates are the rest of the genotype X, while the phenotype Y and the propensity score e(X) are incorporated in the sample weights.

If not stated otherwise, the full data pipeline is written in the R language. The methods presented in this work are implemented in the R package epiGWAS, which is directly available via CRAN. The source code can also be downloaded from the GitHub repository https://github.com/EpiSlim/epiGWAS.

Modified outcome regression

Depending on the underlying target value and the binarization rule, only one of the two possibilities A = +1 or A = −1 is observed for a given sample. In other words, as in randomized controlled trials where, for each sample, either the treatment is applied or it is not, here, for any given sample, we do not observe the phenotype associated with the same genotype except in A which takes the other value. Hence δ(X) cannot be estimated directly from GWAS data using Eq (2). The propensity score comes into play to circumvent this problem. By considering the new binarized variable A˜=(A+1)/2{0,1}, we can indeed use the fact that

{E[YA˜|X]=E[Y|X,A˜=1]e(X),E[Y(1-A˜)|X]=E[Y|X,A˜=0](1-e(X)),

to rewrite Eq (2) as:

δ(X)=12E[Y˜|X], (3)

where we define the modified outcome Y˜ of an observation (X, A, Y) as:

Y˜=Y(A˜e(X)-1-A˜1-e(X)). (4)

Our definition of modified outcome in Eq (4) generalizes that of Tian et al. [14], where it is defined as Y˜=YA˜; both definitions are equivalent in the specific situation considered by Tian et al. [14] where A and X are independent, i.e., e(x) = 1/2 for all x. Our definition (4) remains valid even when A and X are not independent, and can therefore accommodate the diversity of the LD landscape and of the broad range of minor allele frequencies.

Given Eq (3), we propose to estimate the support of δ from GWAS data by first transforming them into genotype-modified outcome pairs (Xi,Y˜i)i=1,,n, and then applying a sparse least-squares regression model for support recovery. For that purpose, we use an elastic net linear regression model, combined with a stability selection procedure for support selection, as subsequently discussed in this paper.

In practice, however, creating the modified outcome Y˜i from a triplet (Xi, Ai, Yi) using (4) raises two issues: (i) the propensity score e(Xi) must be known, and (ii) when the propensity score is close to 0 or 1, then the propensity score weighting may create numerical instability and large variance in the estimation of δ. Similar problems arise in the causal inference literature, particularly for techniques based on inverse propensity score weighting techniques (IPW) [25] and we consider four standard approaches to form modified outcomes with inverse propensity score weights. They all start with an estimate e^(X) of the true propensity score, which we later explain.

  • Modified outcomes are simply obtained by replacing e(Xi) by its estimate e^(Xi) in (4):
    Y˜i=Yi(A˜ie^(Xi)-1-A˜i1-e^(Xi)).
  • Shifted modified outcomes are obtained by simply adding a small term ξ = 0.1 to the denominators in order to limit the inverse propensity score weight of each individual to a maximum of 1/ξ:
    Y˜i=Yi(A˜ie^(Xi)+ξ-1-A˜i1-e^(Xi)+ξ).
  • Normalized modified outcomes are obtained by scaling differently the inverse propensity scores of individuals with A˜=0 and A˜=1, so that the total weights of individuals in each group is the same. This normalization was shown to be beneficial empirically for the estimation of average treatment effect in causal inference with IPW estimators [26]:
    Y˜i=Yi(w1A˜ie^(Xi)-w01-A˜i1-e^(Xi)),
    where, for t = 0, 1,
    wt=(j=1ntA˜je^(Xj)+(1t)1A˜j1e^(Xj))1.
  • Robust modified outcomes are also borrowed from the causal inference literature, and were shown to have small large-sample variance when used for average treatment effect prediction with IPW estimators [26]:
    Y˜i=Yi(w1(1-C1e^(Xi))A˜ie^(Xi)-w0(1-C01-e^(Xi))1-A˜i1-e^(Xi)),
    where, for t = 0, 1,
    Ct=j=1nA˜j-e^(Xi)te^(Xi)+(t-1)(1-e^(Xi))j=1n[A˜j-e^(Xi)te^(Xi)+(1-t)(1-e^(Xi))]2,
    and
    wt=(j=1nt(1C1e^(Xi))A˜je^(Xj)+(1t)(1C01e^(Xi))1A˜j1e^(Xj))1.

Outcome weighted learning

Inspired by the outcome weighted learning (OWL) model of Zhao et al. [15], developed in the context of randomized clinical trials, we now propose an alternative to the modified outcome approach to estimate δ(X) and its support using a weighted binary classification formulation. As with OWL, this formulation mathematically amounts to predicting A from X, where prediction errors are weighted according to Y in the fitting process. In the original OWL proposal, the goal is to determine an optimal individual treatment rule d* that predicts treatment A from prognostic variables X so as to maximize the clinical outcome Y. In our context, this translates to determining an optimal predictor d* that predicts target SNP A from genotype X, so as to maximize Y (which is larger for cases than controls). We expect such a predictor to rely on the SNPs that interact with A towards predicting the phenotype Y. We assume in this section that Y only takes nonnegative values, e.g., Y ∈ {0, 1} for a case-control study. To take into account the dependency between A and X, we replace P(A) with P(A|X) in the original OWL definition [15] and look for the following decision rule:

d*argmind:{0,1,2}pRE[YP(A|X)ϕ(Ad(X))], (5)

where ϕ is a non-increasing loss function such as the logistic loss:

uR,ϕ(u)=log(1+e-u). (6)

The reason to consider this formulation is that:

Lemma 1. The solution d* to (5), (6) is:

x{0,1,2}p,d*(x)=lnE[Y|A=+1,X=x]E[Y|A=-1,X=x].

Proof. For any x ∈ {0, 1, 2}p, we see from Eq (5) that d*(x) must minimize the function l:RR defined by

uR,l(u)=E[YP(A|X=x)ϕ(Au)|X=x]=ϕ(u)E[Y|A=1,X=x]+ϕ(-u)E[Y|A=-1,X=x].

This function is minimized when l′(u) = 0, that is, when ϕ(u)E[Y|A=1,X=x]=ϕ(-u)E[Y|A=-1,X=x], which is equivalent to:

E[Y|A=1,X=x]E[Y|A=-1,X=x]=eu.

Lemma 1 clarifies how d* is related to δ as defined in Eq (2): while δ is half the difference between the expected phenotype conditioned on the two alternative values of A, d* is the log-ratio of the same two quantities. In particular, both functions have the same sign for any genotype X. Hence we propose to estimate d* and its support, as an approximation and alternative to estimating δ and its support, in order to capture SNPs in epistasis with A.

For any given (X, A, Y), if we define the weight W = Y/P(A|X), we can interpret d* in Eq (5) as a logistic regression classifier that predicts A from X, with errors weighted by W. Hence d* and its support can be estimated from GWAS data by standard tools for weighted logistic regression and support estimation. We use an elastic net logistic regression model, combined with a stability selection procedure for model selection, detailed afterwards.

In the case of qualitative GWAS studies, we encode Y as 0 for controls and 1 for cases. The sample weights W of controls thus become 0, resulting in a case-only approach for epistasis detection. Tools such as PLINK [27] and INTERSNP [28] similarly implement case-only analyses, which can be more powerful in practice than a joint case-control analysis [4, 2931]. In the case of PLINK and INTERSNP, additional hypotheses such as the independence of SNP–SNP frequencies are nonetheless needed to ensure the validity of the statistical test. In our case, the family of weights {Wi = 1/P(Ai|Xi)}i=1,⋯,n accounts for the dependency between the target A and the genotype X. We can therefore forego such hypotheses on the data. We may even argue that the controls are indirectly included in the regression model through P(A|X). It represents the dependency pattern within the general population, which consists of both cases and controls.

Estimate of the propensity score

In causal inference, the estimation of propensity scores e(X) = P(A = 1|X) is often achieved thanks to parametric models such as a logistic regression between A and X. Because of the risk of overfitting in such an ultra high-dimensional setting, we turn instead towards hidden Markov models, which are commonly used in genetics to model linkage disequilibrium and were initially developed for imputation [32]. In this model (see the S1 File), the hidden states represent contiguous clusters of phased haplotypes. The emission states correspond to SNPs.

Since the structural dependence is chromosome-wise, we only retain the SNPs located on the same chromosome as the SNP A—which we denote here by XA—for the estimate of P(A|X). Mathematically, this is equivalent to the independence of the SNPs A and XA from the SNPs of other chromosomes.

The pathological cases P(A|XA) ≈ 1 and P(A|XA) ≈ 0 can be avoided by the removal of all SNPs within a certain distance of A. In our implementation, we first perform an adjacency-constrained hierarchical clustering of the SNPs located on the chromosome of the target A. We fix the maximum correlation threshold at 0.5. To alleviate strong linkage disequilibrium, we then discard all neighboring SNPs within a three-cluster window of SNP A. Such filtering is sensible since we are looking for biological interactions between functionally-distinct regions. The neighboring SNPs are not only removed for the estimation of the propensity score, but also in the regression models searching for interactions.

After the filtering and the fitting of the unphased genotype model using fastPHASE, the last remaining step is the application of the forward algorithm [33] to obtain an estimate of the two potential observations (A = 1, XA) and (A = −1, XA). Bayes theorem then yields the desired probability P(A|X) = P(A|XA) = P(A, XA)/(P(A = +1, XA) + P(A = −1, XA)).

Support estimation

In order to estimate the support of δ in the case of modified outcome regression (3), and of d* in the case of OWL (5), we model both functions as linear models and estimate non-zero coefficients by elastic net regression [34] combined with stability selection [18, 19].

More precisely, given a GWAS cohort (Xi, Ai, Yi)i=1,…,n, we first define empirical risks for a candidate linear model xγ x for δ and d* as respectively

R1(γ)=1ni=1n(Y˜i-γXi)2,R2(γ)=1ni=1nYiP(Ai|Xi)ϕ(AiγXi).

For a given regularization parameter λ > 0 and empirical risk R = R1 or R = R2, we then define the elastic net estimator:

γλ^argminγR(γ)+λ[(1-s)γ1+12sγ22],

where we fix s = 10−6 to give greater importance to the L1-penalization. Over a grid of values Λ for the penalization parameter λ, we subsample N = 50 times without replacement over the whole cohort. The size of the generated subsamples I1, ⋯, IN is ⌊n/2⌋. Each subsample I provides a different support for γ^λ, which we denote S^λ(I). For λ ∈ Λ, the empirical frequency of the variable Xk entering the support is then given by:

ω^kλ=1Nj=1N1(kS^λ(Ij)).

In the original stability selection procedure [18], the decision rule for including the variable k in the final model is maxλΛω^kλt. The parameter t is a predefined threshold. For noisy high-dimensional data, the maximal empirical frequency along the stability path maxλΛω^kλ may not be sufficiently robust because of its reliance on a single noisy measure of ω^kλ to derive the maximum. Instead, we used the area under the stability path, λω^kλdλ, as propsed by Haury et al. [19]. The main intuition behind the better performance is the early entry of causal variables into the LASSO path.

Finally, to determine the grid Λ, we use the R package glmnet [35]. We generate a log-scaled grid of 200 values (λl)l=1,⋯,200 between λ1 = λmax and λ200 = λmax/100, where λmax is the maximum λ leading to a non-zero model. To improve inference, we only retain the first half of the path comprised between λ1 and λ100. The benefit of a thresholded regularization path is to discard a large number of irrelevant covariates that enter the support for low values of λ.

Results

Simulations

Disease model

We simulate phenotypes using a logit model with the following structure:

logit(P(Y=1|A˜=i,X))=βi,VTXV+βWTXW+XZ1Tdiag(βZ1,Z2)XZ2,

where V, W, Z1 and Z2 are random subsets of {1, ⋯, p}. The variables within the vector XV interact with A. The variables in XW corresponds to marginal effects, while XZ1 and XZ2 correspond to pairs of quadratic effects between SNPs that exclude A. The effect sizes β0,V, β1,V, βW and βZ1,Z2 are sampled from N(0,1). Given the symmetry around 0 of the effect size distributions, the simulated cohorts are approximately equally balanced between cases and controls.

To account for the diversity of effect types in disease models, we simulate four scenarios with different overlap configurations between XV and (XW,XZ1):

  • Synergistic only effects, |VW| = 0, |VZ1| = 0, |V| = |W| = |Z1| = |Z2| = 8;

  • Partial overlap between synergistic and marginal effects, |VW| = 4, |VZ1| = 0, |V| = |W| = |Z1| = |Z2| = 8;

  • Partial overlap between synergistic and quadratic effects, |VW| = 0, |VZ1| = 4, |V| = |W| = |Z1| = |Z2| = 8;

  • Partial overlap between synergistic and quadratic/marginal effects, |VW| = 2, |VZ1| = 2, |V| = |W| = |Z1| = |Z2| = 8.

For each of the above scenarios, we conduct 125 simulations: 5 sets of causal SNPs {A, V, W, Z1, Z2} × 5 sets of size effects {β0,V, β1,V, βW, βZ1,Z2} × 5 replicates. Within each scenario, we consider multiple SNP sets to model the range of MAFs and LD which can exist between A and X.

Because of the filtering window around the SNP A, the causal SNPs (XV, XW, Z1, Z2) are sampled outside of that window. The second constraint on the causal SNPs is a lower bound on the minor allele frequencies (MAF). We fix that bound at 0.2. The goal is to obtain well-balanced marginal distributions for the different variants. For rare variants, it is difficult to untangle the statistical power of any method from the inherent difficulty in detecting them. The lower bound is also coherent with the common disease-common variant hypothesis [36]: the main drivers of complex/common diseases are common SNPs.

Genotype simulations

For the sake of coherence, we simulate genotypes using the second release of HAPGEN [37]. The underlying model for HAPGEN is the same hidden Markov model used in fastPHASE. The starting point of the simulations is a reference set of population haplotypes. The accompanying haplotypes dataset is the 1000 Genomes phase 3 reference haplotypes [38]. In our simulations, we only use the European population samples. The second input to HAPGEN is a fine scale recombination map. Consequently, the simulated haplotypes/genotypes exhibit the same linkage disequilibrium structure as the original reference data.

In comparison to the HAPGEN-generated haplotypes, the markers density for SNP arrays is significantly lower. For example, the sequencing technology for the WTCCC case-control consortium [39] is the Affymetrix 500K. As its name suggests, “only” five hundred thousand positions are genotyped. As most GWAS are based on SNP array data, we only extract from the simulated genotypes the markers of the Affymetrix 500K. In the subsequent QC step, we only retain common bi-allelic SNPs defined by a MAF > 0.01. We also remove SNPs that are not in a Hardy-Weinberg equilibrium (p < 10−6). We do not conduct any additional LD pruning for the SNPs in X. For univariate GWAS, LD pruning reduces dimensionality while approximately maintaining the same association patterns between genotype and phenotype. For second order interaction effects, the loss of information can be more dramatic, as the retained SNP pairs can be insufficient to represent the complex association of corresponding genomic regions with the phenotype.

For iterative simulations, HAPGEN can be time-consuming, notably for large cohorts consisting of thousands of samples. We instead proceed in the following way: we generate once and for all a large dataset of 20 thousand samples on chromosome 22. To benchmark for varying sample sizes n ∈ {500, 1000, 2000, 5000}, we iteratively sample uniformly and without replacement n-times the population of 20000 individuals to create 125 case-control cohorts. On chromosome 22, we then select p = 5000 SNPs located between the nucleotide positions 16061016 and 49449618. We do not conduct any posterior pruning to avoid filtering out the true causal SNPs.

Evaluation

We benchmark our new methods against two baselines. The first method is GBOOST [9], a state-of-the-art method for epistasis detection. For each SNP pair, it implements the log-likelihood ratio statistic to compare the goodness of fit of two models: the full logistic regression model with both main effect and interaction terms, and the logistic regression model with main effects only. The preliminary sure screening step in GBOOST to discard a number of SNPs from exhaustive pairwise testing was omitted, since we are only interested in the ratio statistic for all pairs of the form (A, Xk), where Xk is the k-th SNP in X. The second method, which we refer to as product LASSO, originates from the machine learning community. It was developed by Tian et al. [14] to estimate interactions between a treatment and a large number of covariates. It fits an L1-penalized logistic regression model with A × X as covariates. The variable of interest A is symmetrically encoded as {−1, +1}. Under general assumptions, Tian et al. [14] show how this model works as a good approximation to the optimal decision rule d*.

We visualize the support estimation performance in terms of receiver-operating characteristic (ROC) curves and precision-recall (PR) curves. For a particular method in a given scenario, a single ROC (resp. PR) curve allows to visualize the ability of the algorithm to recover causal SNPs. For each SNP, the prediction score is the area under its corresponding stability path. The ground truth label is 1 for the SNPs interacting with the target A, and 0 otherwise. In the high-dimensional setting of GWAS, the use of raw scores instead of p-values lends more robustness to our methods, by avoiding finite-sample approximations of the score distributions and multiple hypothesis corrections.

The covariates and the outcome differ between our methods. That implies a different regularization path for each method and as a result, incomparable stability paths. For better interpretability and comparability between the methods, we use the position l on the stability path grid Λ = (λl) s.t. λl > λl+1 instead of the value of λl for computing the area under the curve.

In Fig 1, we provide the ROC and PR curves for the fourth scenario which corresponds to a partial overlap between synergistic and quadratic/marginal effects and for a sample size n = 500. Because of space constraints, all ROC/PR figures and corresponding AUC tables are listed in the S2 File. The figures represent the average ROC and PR curves of the 125 simulations in each of the four scenarios. To generate those figures, we used the R package precrec [40]. It performs nonlinear interpolation in the PR space. The AUCs are computed with same package.

Fig 1. Average ROC (left) and PR (right) curves for the fourth scenario and n = 500.

Fig 1

Regardless of the scenario and the sample size, the areas under all ROC curves are higher than 0.5. This confirms that all of them perform better than random, yet with varying degrees of success. By contrast, the overall areas under the precision-recall curves are low. The maximum area under the precision-recall curve is 0.41, attained by modified outcome with shifted weights for n = p. This can be attributed to the imbalanced nature of the problem: 8 synergistic SNPs out of 5000. We also check that the AUCs increase with the cohort size for both ROC and PR domains.

The best performing methods are robust modified outcome and GBOOST. Robust modified outcome has a slight lead in terms of ROC AUCs, notably for low sample sizes. The latter setup is the closest to our intended application in genome-wide association studies. Of special interest to us in the ROC space is the bottom-left area. It reflects the performance of highly-ranked instances. For all scenarios, we witness a better start for robust modified outcome. The other methods within the modified outcome family behave similarly. Such a result was expected because of their theoretical similarities. Despite the model misspecification, product LASSO performs rather well. On average, it comes third to GBOOST and robust modified outcome. The outcome weighted learning approach which is an approximation to estimating the sign of δ has consistently been the worst performer in the ROC space.

In PR space, the results are more mixed. For low sample sizes, robust modified outcome is still the best performing method. As the sample size increases, we observe that other methods within the modified outcome family, notably shifted modified outcome, surpass the robust modified outcome approach. Surprisingly, the good performance of GBOOST in ROC space was not reproduced in PR space. This might be explained by the highly imbalanced nature of the problem and the lower performance of GBOOST, compared to robust modified outcome in the high specificity region of the ROC curves (lower left). By contrast, product LASSO is always trailing the best performer of the modified outcome family. As for ROC curves, we are also interested in the beginning of the PR curves. For a recall rate of 0.125, the highest precision rate is near 0.5 for the first, third and fourth scenarios. That implies that we detect on average one causal SNP in the first two SNPs. For the second scenario, the highest precision rate is even higher at approximately 0.68. The area under the stability path is then a robust score for model selection in the high dimensional setting.

It is worth noting the homogeneous behavior of the different methods across the four scenarios. For a given sample size, and for a given method, the ROC and PR AUCs are similar. This suggests they all successfully filtered out the common effects term μ(X) even in presence of an overlap between the causal SNPs within μ(X) and δ(X).

Case study: Type II diabetes dataset of the WTCCC

As a case study, we selected the type II diabetes dataset of the WTCCC [39] to illustrate the scalability of our methods to real datasets. To the best of our knowledge, no confirmed epistatic interactions exist for type II diabetes. We instead propose to study the synergies with a particular target: rs41475248 on chromosome 8. We focus on this target SNP because (i) GBOOST finds that it is involved in 3 epistatic interactions, when controlling for a false discovery rate of 0.05, and (ii) it is a common variant, with a MAF of 0.45.

Before running our methods on the WTCCC dataset, we applied the same QC procedures with the following thresholds: 0.01 for minor-allele frequencies and p > 10−6 for the Hardy-Weinberg equilibrium. No additional pruning is performed. The number of remaining variants is 354439 SNPs. The number of samples is 4897, split between 1953 cases and 2944 controls.

To solve the different L1-penalized regressions, we abandoned the glmnet package in favor of another one, biglasso [41]. Indeed, glmnet does not accept as input such ultra-high dimensional design matrices. On the other hand, biglasso was specifically developed for similar settings thanks to its multi-threaded implementation and utilization of memory-mapped files. Because biglasso does not implement sample weighting, it cannot be used to run outcome weighted learning. Since this approach performs worse than the modified outcome approaches on simulated data, we simply exclude it from this case study.

The main difficulty for the evaluation of GWAS methods is the biological validation of the study results. We often lack evidence to correctly label each SNP as being involved or not in an epistatic interaction. Evaluating the real model selection performance of the different methods on real datasets is then impossible. However, we can study the concordance between them. A common way to proceed is Kendall’s tau which is a measure of rank correlation. In Table 1, we give the correlation matrix of our four variants of modified outcome methods, and of the two baseline methods GBOOST and product LASSO. All elements are positive which indicates a relative agreement between the methods. While methods using different mathematical definitions of epistasis cannot be expected to return the same results, those with similar or identical underlying models should capture similar genetic architectures and return more similar results. Modified outcome, normalized modified outcome and shifted modified outcome have the highest correlation coefficients. Such a result was expected because of their theoretical similarities. We also note that the lowest score is for robust modified outcome and GBOOST. In the previous section, these two methods were the best performing. This suggests those two methods can make different true discoveries.

Table 1. Concordance between methods used to determine SNPs synergistic to rs41475248 in type II diabetes, measured by Kendall’s tau.

GBOOST Modified outcome Normalized modified outcome Shifted modified outcome Robust modified outcome Product LASSO
GBOOST 1.000 0.200 0.203 0.202 0.070 0.152
Modified outcome 0.200 1.000 0.411 0.405 0.150 0.283
Normalized modified outcome 0.203 0.411 1.000 0.406 0.153 0.284
Shifted modified outcome 0.202 0.405 0.406 1.000 0.179 0.301
Robust modified outcome 0.070 0.150 0.153 0.179 1.000 0.257
Product LASSO 0.152 0.283 0.284 0.301 0.257 1.000

In any follow-up work, we will only exploit the highly-ranked variants. A weighted tau statistic that assigns a higher weight to the first instances is therefore more relevant. Weighted nonnegative tau statistics better assess the relative level of concordance between different pairs of methods, while the sign in Kendall’s tau shows if two methods rather agree or disagree. In Table 2, we list Kendall’s tau coefficients with multiplicative hyperbolic weighting. Similarly, we notice that robust modified outcome is least correlated with GBOOST and most correlated with product LASSO.

Table 2. Concordance between methods used to determine SNPs synergistic to rs41475248 in type II diabetes, measured by Kendall’s tau with multiplicative weights.

GBOOST Modified outcome Normalized modified outcome Shifted modified outcome Robust modified outcome Product LASSO
GBOOST 1.000 0.483 0.481 0.517 0.423 0.501
Modified outcome 0.483 1.000 0.851 0.857 0.462 0.586
Normalized modified outcome 0.481 0.851 1.000 0.860 0.467 0.594
Shifted modified outcome 0.517 0.857 0.860 1.000 0.504 0.603
Robust modified outcome 0.423 0.462 0.467 0.504 1.000 0.596
Product LASSO 0.501 0.586 0.594 0.603 0.596 1.000

Aside from rank correlation, another option to appraise the results is to measure the association between the top SNPs for each method and the phenotype. Table 3 lists the Cochran-Armitage test p-values for the top 25 SNPs for each method in an increasing order. Despite being synthetic univariate measures, the Cochran-Armitage statistics give us an indication of the true ranking performance. Robust modified outcome is clearly the method with the lowest p-values. For instance, the top 14 SNPs have a p-value lower than 0.001. That confirms the result of our simulations that robust modified outcome is the best performer for capturing causal SNPs. The p-values associated to product LASSO and GBOOST are also relatively low, with respectively 5 and 4 p-values lower than 0.001. However, we note the overall difficulty in drawing clear conclusions for all methods. Without multiple testing correction, most of the p-values for each method already exceed classical significance levels e.g. 0.05. For 3 out of 6 methods, the p-values of the 25th SNP are greater than 0.90. Nonetheless, the existence of such high p-values further demonstrates the capacity of our methods in discovering novel associations undetected by univariate methods.

Table 3. Cochran-Armitage test p-values for the top 25 SNPs for each method.

GBOOST Modified outcome Normalized modified outcome Shifted modified outcome Robust modified outcome Product LASSO
0.0000047 0.0000000 0.0000000 0.0000000 0.0000000 0.0000047
0.0002632 0.0000015 0.0000015 0.0000015 0.0000000 0.0000075
0.0002667 0.0002667 0.0002667 0.0002667 0.0000001 0.0000172
0.0006166 0.0027308 0.0027308 0.0027308 0.0000012 0.0002667
0.0015069 0.0093734 0.0093734 0.0093734 0.0000049 0.0005286
0.0028872 0.0633055 0.0633055 0.0633055 0.0000059 0.0110392
0.0031533 0.0724198 0.0724198 0.0724198 0.0000075 0.0122543
0.0034323 0.0925877 0.0925877 0.0771170 0.0000172 0.0152912
0.0081128 0.1126164 0.1043632 0.0925877 0.0002030 0.0346055
0.0093734 0.1272777 0.1126164 0.1126164 0.0002667 0.0347964
0.0142695 0.2552284 0.1567974 0.1272777 0.0003047 0.0396448
0.0633055 0.2926915 0.2971396 0.1639805 0.0004643 0.0396932
0.0771170 0.3436741 0.3529366 0.2971396 0.0005286 0.0527104
0.1616393 0.3529366 0.5012038 0.3529366 0.0005841 0.0633055
0.2089538 0.5871432 0.5506690 0.5012038 0.0015214 0.0763114
0.2114803 0.5985624 0.5985624 0.5707955 0.0016353 0.1126164
0.2256368 0.6016953 0.7183847 0.5985624 0.0025709 0.1185275
0.2586186 0.6361937 0.7199328 0.7000506 0.0064196 0.1796624
0.2654530 0.7183847 0.7342897 0.7183847 0.0080405 0.2552284
0.4105146 0.7342897 0.7656055 0.7342897 0.0110392 0.3308890
0.4323674 0.7979653 0.7706524 0.7979653 0.0122543 0.3867409
0.4376669 0.8683271 0.7979653 0.7993838 0.0124442 0.5045073
0.4796214 0.8820292 0.7993838 0.8683271 0.0136452 0.5985624
0.5871432 0.9188037 0.8820292 0.8821872 0.0346055 0.6238335
0.9479547 0.9903334 0.8821872 0.9188037 0.0396932 0.8821872

Discussion

In this paper, we have proposed several methods, inspired from the causal inference literature, to select SNPs having synergystic effects with a particular target SNP towards a phenotype. The consistency of our results across the four disease models show that the proposed methods are rather successful. Indeed, their performance is not strongly impacted by the presence/absence of other marginal and epistatic effects. Among the methods we propose, robust modified outcome is the most suited to real GWAS applications. Its superior performance is partially due to its robustness against propensity score misspecification. The AUCs for robust modified outcome are overall the highest in addition to its retrieval performance for highly-ranked instances. More importantly, robust modified outcome outperforms GBOOST and other regression-based methods. This is particularly true for small number of samples (n = 500), which is the closest setup to real GWAS datasets. However, the low PR AUCs show that there is still room for improvement. The highest observed PR AUC is 0.17. Interestingly, we note that several of our methods clearly outperform GBOOST across all scenarios and all sample sizes in the PR space. Nonetheless, GBOOST behaves similarly to our methods in the ROC space. Such differences between ROC and PR curves are common for highly-imbalanced datasets where PR curves are more informative and discriminative [42].

In our simulations, ROC and PR AUCs were relatively close between all methods. On the other hand, according to two rank correlation measures (Kendall’s tau and weighted Kendall’s tau), the results do not strongly overlap between the different methods (values far from 1). For instance, GBOOST least agrees with robust modified outcome. However, the two methods are the best performing in our simulations. Different approaches seem to discover different types of interactions [43]. We conclude that a consensus method combining GBOOST and robust modified outcome could better improve the recovery of interacting SNPs.

Across all simulation settings, OWL was the worst-performing method. This is expected given the fact that OWL is only a sign approximation to modified outcome. In OWL, the common effects term is not completely filtered out, which explains the observed gap in performance between the two approaches. Despite this limitation, OWL remains statistically valid, in the sense that its support recovery performance increases with the sample size (see the S2 File). In practical settings, we naturally recommend the use of the modified outcome approaches which linearity allow a complete filtering of common effects, and consequently yield a better performance.

The carried simulations prove that the highly-ranked SNPs include false positives. This is accentuated by the imbalanced nature of our problem: a handful of causal SNPs for thousands of referenced SNPs. Hopefully, the continual decrease in genotyping costs will result in a dramatic increase in sample sizes and, in consequence, statistical power. For instance, the UK Biobank [44] comprises full genome-wide data for five hundred thousand individuals.

The case study that we carried for type II diabetes demonstrates the scalability of our methods to real GWAS. To reduce runtime, one can reduce the number of subsamples used for stability selection; however this may come at the expense of performance. The development of new and faster LASSO solvers [45, 46] for large scale problems will further help broaden the adoption of our methods by end-users without compromising statistical performance.

The main contribution of our work is extending the causal inference framework to epistasis detection by developing a new family of methods. They rely on propensity scores to detect interactions with specific SNP targets. Given our partial understanding of common diseases and the overall lack of statistical power of existing tools, such refocused models can be more useful to further our understanding of disease etiologies. Hundreds of genes have already been associated with several diseases via univariate GWAS. The next step is to leverage such findings to detect additional synergies between these genes and the rest of the genome. Beyond a better understanding of disease mechanisms through new biomarker discovery, we see the development of combination drug therapies as an additional application of our work.

A first area of future improvement for our methods is propensity score estimation, which can benefit from a large number of recent methods [47]. A second area is incorporating multiple covariates (whether clinical covariates, variables encoding population structure or other genetic variants) to account for, among other things, higher-order interactions and population structure. A straightforward solution is to include additional variables in X, which encode for the other covariates. However, this will impact the consistency and interpretability of the propensity scores. A second potential solution is the use of modified targets which combine the original target with the other covariates e.g. target × gender. We think that such outcomes have not been explored because of the insufficiency of the representation by a single binary variable. To address this issue we can, for example, borrow some of the ideas in VanderWeele and Hernan [48] to construct richer representations.

Supporting information

S1 File. Genotypic hidden Markov model.

(PDF)

S2 File. Simulation results.

(PDF)

Data Availability

All relevant data are within the manuscript and its Supporting information files.

Funding Statement

This study makes use of data generated by the Wellcome Trust Case-Control Consortium. A full list of the investigators who contributed to the generation of the data is available from http://www.wtccc.org.uk. Funding for the project was provided by the Wellcome Trust under award 076113, 085475 and 090355. In the form of salaries, L. S. and C. C. were supported in their research by SANOFI and JP. V. by Google. These companies did not have any additional roles in the study design, data collection and analysis, decision to publish, or preparation of the manuscript. The specific roles of these authors are articulated in the ‘author contributions’ section.

References

  • 1. Combarros O, Cortina-Borja M, Smith AD, Lehmann DJ. Epistasis in sporadic Alzheimer’s disease. Neurobiology of Aging. 2009;30(9):1333–1349. 10.1016/j.neurobiolaging.2007.11.027 [DOI] [PubMed] [Google Scholar]
  • 2. Harty BL, Coelho F, Pease-Raissi SE, Mogha A, Ackerman SD, Herbert AL, et al. Myelinating Schwann cells ensheath multiple axons in the absence of E3 ligase component Fbxw7. Nature Communications. 2019;10(1):2976 10.1038/s41467-019-10881-y [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 3. Galarza-Muñoz G, Briggs FBS, Evsyukova I, Schott-Lerner G, Kennedy EM, Nyanhete T, et al. Human Epistatic Interaction Controls IL7R Splicing and Increases Multiple Sclerosis Risk. Cell. 2017;169(1):72–84.e13. 10.1016/j.cell.2017.03.007 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 4. Cordell HJ. Detecting gene–gene interactions that underlie human diseases. Nature Reviews Genetics. 2009;10(6):392–404. 10.1038/nrg2579 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 5. Niel C, Sinoquet C, Dina C, Rocheleau G. A survey about methods dedicated to epistasis detection. Frontiers in Genetics. 2015;6(SEP). 10.3389/fgene.2015.00285 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 6. Cabin RJ, Mitchell RJ. To Bonferroni or not to Bonferroni: when and how are the questions. Bulletin of the Ecological Society of America. 2000;81(3):246–248. [Google Scholar]
  • 7. Benjamini Y, Hochberg Y. Controlling the False Discovery Rate: A Practical and Powerful Approach to Multiple Testing. Journal of the Royal Statistical Society Series B (Methodological). 1995;57(1):289–300. 10.1111/j.2517-6161.1995.tb02031.x [DOI] [Google Scholar]
  • 8. Nakagawa S. A farewell to Bonferroni: the problems of low statistical power and publication bias. Behavioral Ecology. 2004;15(6):1044–1045. 10.1093/beheco/arh107 [DOI] [Google Scholar]
  • 9. Wan X, Yang C, Yang Q, Xue H, Fan X, Tang NLS, et al. BOOST: A fast approach to detecting gene-gene interactions in genome-wide case-control studies. American Journal of Human Genetics. 2010;87(3):325–340. 10.1016/j.ajhg.2010.07.021 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 10. Yung LS, Yang C, Wan X, Yu W. GBOOST: a GPU-based tool for detecting gene–gene interactions in genome–wide case control studies. Bioinformatics. 2011;27(9):1309–1310. 10.1093/bioinformatics/btr114 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 11. Thanei GA, Meinshausen N, Shah RD. The xyz algorithm for fast interaction search in high-dimensional data. Journal of Machine Learning Research. 2018;19(37):1–42. [Google Scholar]
  • 12. Tibshirani R. Regression Shrinkage and Selection Via the Lasso. Journal of the Royal Statistical Society: Series B (Methodological). 1996;58(1):267–288. 10.1111/j.2517-6161.1996.tb02080.x [DOI] [Google Scholar]
  • 13. Bien J, Taylor J, Tibshirani R. A lasso for hierarchical interactions. The Annals of Statistics. 2013;41(3):1111–1141. 10.1214/13-AOS1096 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 14. Tian L, Alizadeh AA, Gentles AJ, Tibshirani R. A Simple Method for Estimating Interactions Between a Treatment and a Large Number of Covariates. Journal of the American Statistical Association. 2014;109(508):1517–1532. 10.1080/01621459.2014.951443 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 15. Zhao Y, Zeng D, Rush AJ, Kosorok MR. Estimating Individualized Treatment Rules Using Outcome Weighted Learning. Journal of the American Statistical Association. 2012;107(499):1106–1118. 10.1080/01621459.2012.695674 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 16. Slatkin M. Linkage disequilibrium—understanding the evolutionary past and mapping the medical future. Nature Reviews Genetics. 2008;9(6):477–485. 10.1038/nrg2361 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 17. Rubin DB. Estimating causal effects of treatments in randomized and nonrandomized studies. Journal of Educational Psychology. 1974;66(5):688–701. 10.1037/h0037350 [DOI] [Google Scholar]
  • 18. Meinshausen N, Bühlmann P. Stability selection. Journal of the Royal Statistical Society: Series B (Statistical Methodology). 2010;72(4):417–473. 10.1111/j.1467-9868.2010.00740.x [DOI] [Google Scholar]
  • 19. Haury AC, Mordelet F, Vera-Licona P, Vert JP. TIGRESS: Trustful Inference of Gene REgulation using Stability Selection. BMC Systems Biology. 2012;6 10.1186/1752-0509-6-145 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 20. Székely GJ, Rizzo ML, Bakirov NK. Measuring and testing dependence by correlation of distances. The Annals of Statistics. 2007;35(6):2769–2794. 10.1214/009053607000000505 [DOI] [Google Scholar]
  • 21. Cover TM, Thomas JA. Elements of Information Theory. John Wiley & Sons, Inc; 2005. 10.1002/047174882x. [DOI] [Google Scholar]
  • 22. Prabhu S, Pe’er I. Ultrafast genome-wide scan for SNP-SNP interactions in common complex disease. Genome Research. 2012;22(11):2230–2240. 10.1101/gr.137885.112 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 23. Llinares-López F, Papaxanthos L, Roqueiro D, Bodenham D, Borgwardt K. CASMAP: detection of statistically significant combinations of SNPs in association mapping. Bioinformatics. 2018;35(15):2680–2682. 10.1093/bioinformatics/bty1020 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 24.Achlioptas P, Schölkopf B, Borgwardt K. Two-locus association mapping in subquadratic time. In: Proceedings of the 17th ACM SIGKDD international conference on Knowledge discovery and data mining—KDD’11. ACM Press; 2011. 10.1145/2020408.2020521. [DOI]
  • 25. Rosenbaum PR, Rubin DB. The Central Role of the Propensity Score in Observational Studies for Causal Effects. Biometrika. 1983;70(1):41–55. 10.1093/biomet/70.1.41 [DOI] [Google Scholar]
  • 26. Lunceford JK, Davidian M. Stratification and weighting via the propensity score in estimation of causal treatment effects: A comparative study. Statistics in Medicine. 2004;23(19):2937–2960. 10.1002/sim.1903 [DOI] [PubMed] [Google Scholar]
  • 27. Purcell S, Neale B, Todd-Brown K, Thomas L, Ferreira MAR, Bender D, et al. PLINK: A Tool Set for Whole-Genome Association and Population-Based Linkage Analyses. The American Journal of Human Genetics. 2007;81(3):559–575. 10.1086/519795 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 28. Herold C, Steffens M, Brockschmidt FF, Baur MP, Becker T. INTERSNP: genome-wide interaction analysis guided by a priori information. Bioinformatics. 2009;25(24):3275–3281. 10.1093/bioinformatics/btp596 [DOI] [PubMed] [Google Scholar]
  • 29. Gatto NM. Further development of the case-only design for assessing gene-environment interaction: evaluation of and adjustment for bias. International Journal of Epidemiology. 2004;33(5):1014–1024. 10.1093/ije/dyh306 [DOI] [PubMed] [Google Scholar]
  • 30. Piegorsch WW, Weinberg CR, Taylor JA. Non-hierarchical logistic models and case-only designs for assessing susceptibility in population-based case-control studies. Statistics in Medicine. 1994;13(2):153–162. 10.1002/sim.4780130206 [DOI] [PubMed] [Google Scholar]
  • 31. Yang Q, Khoury MJ, Sun F, Flanders WD. Case-only design to measure gene-gene interaction. Epidemiology (Cambridge, Mass). 1999;10(2):167–70. 10.1097/00001648-199903000-00014 [DOI] [PubMed] [Google Scholar]
  • 32. Scheet P, Stephens M. A fast and flexible statistical model for large-scale population genotype data: applications to inferring missing genotypes and haplotypic phase. American journal of human genetics. 2006;78(4):629–44. 10.1086/502802 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 33. Rabiner LR. A tutorial on hidden Markov models and selected applications in speech recognition. Proceedings of the IEEE. 1989;77(2):257–286. 10.1109/5.18626 [DOI] [Google Scholar]
  • 34. Zou H, Hastie T. Regularization and variable selection via the elastic net. Journal of the Royal Statistical Society: Series B (Statistical Methodology). 2005;67(2):301–320. 10.1111/j.1467-9868.2005.00503.x [DOI] [Google Scholar]
  • 35. Friedman J, Hastie T, Tibshirani R. Regularization Paths for Generalized Linear Models via Coordinate Descent. Journal of Statistical Software. 2010;33(1). 10.18637/jss.v033.i01 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 36. Schork NJ, Murray SS, Frazer KA, Topol EJ. Common vs. rare allele hypotheses for complex diseases. Current Opinion in Genetics & Development. 2009;19(3):212–219. 10.1016/j.gde.2009.04.010 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 37. Su Z, Marchini J, Donnelly P. HAPGEN2: simulation of multiple disease SNPs. Bioinformatics. 2011;27(16):2304–2305. 10.1093/bioinformatics/btr341 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 38. Auton Ae. A global reference for human genetic variation. Nature. 2015;526(7571):68–74. 10.1038/nature15393 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 39. Burton PR, et al. Genome-wide association study of 14, 000 cases of seven common diseases and 3, 000 shared controls. Nature. 2007;447(7145):661–678. 10.1038/nature05911 [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 40. Saito T, Rehmsmeier M. Precrec: fast and accurate precision–recall and ROC curve calculations in R. Bioinformatics. 2016;33(1):145–147. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 41.Zeng Y, Breheny P. The biglasso Package: A Memory- and Computation-Efficient Solver for Lasso Model Fitting with Big Data in R. ArXiv e-prints. 2017;.
  • 42.Davis J, Goadrich M. The relationship between Precision-Recall and ROC curves. Proceedings of the 23rd international conference on Machine learning—ICML’06. 2006; p. 233–240. 10.1145/1143844.1143874 [DOI]
  • 43. Bessonov K, Gusareva ES, Steen KV. A cautionary note on the impact of protocol changes for genome-wide association SNP × SNP interaction studies: an example on ankylosing spondylitis. Human Genetics. 2015;134(7):761–773. 10.1007/s00439-015-1560-7 [DOI] [PubMed] [Google Scholar]
  • 44. Bycroft C, Freeman C, Petkova D, Band G, Elliott LT, Sharp K, et al. Genome-wide genetic data on 500,000 UK Biobank participants. bioRxiv. 2017;. 10.1101/166298 [DOI] [Google Scholar]
  • 45.Le Morvan M, Vert J. WHInter: A Working set algorithm for High-dimensional sparse second order Interaction models. In: Proceedings of the 35th International Conference on Machine Learning, ICML 2018, Stockholmsmässan, Stockholm, Sweden, July 10–15, 2018; 2018. p. 3632–3641.
  • 46.Massias M, Gramfort A, Salmon J. Celer: a Fast Solver for the Lasso with Dual Extrapolation. In: ICML 2018—35th International Conference on Machine Learning. vol. 80 of PMLR. Stockholm, Sweden; 2018. p. 3321–3330.
  • 47. Athey S, Imbens GW, Wager S. Approximate residual balancing: debiased inference of average treatment effects in high dimensions. Journal of the Royal Statistical Society: Series B (Statistical Methodology). 2018;. 10.1111/rssb.12268 [DOI] [Google Scholar]
  • 48. VanderWeele TJ, Hernan MA. Causal inference under multiple versions of treatment. Journal of Causal Inference. 2013;1(1):1–20. 10.1515/jci-2012-0002 [DOI] [PMC free article] [PubMed] [Google Scholar]

Decision Letter 0

Jiang Gui

15 Oct 2020

PONE-D-20-16158

Novel methods for epistasis detection in genome-wide association studie

PLOS ONE

Dear Dr. Slim,

Thank you for submitting your manuscript to PLOS ONE. After careful consideration, we feel that it has merit but does not fully meet PLOS ONE’s publication criteria as it currently stands. Therefore, we invite you to submit a revised version of the manuscript that addresses the points raised during the review process.

Please submit your revised manuscript by Nov 29 2020 11:59PM. If you will need more time than this to complete your revisions, please reply to this message or contact the journal office at plosone@plos.org. When you're ready to submit your revision, log on to https://www.editorialmanager.com/pone/ and select the 'Submissions Needing Revision' folder to locate your manuscript file.

Please include the following items when submitting your revised manuscript:

  • A rebuttal letter that responds to each point raised by the academic editor and reviewer(s). You should upload this letter as a separate file labeled 'Response to Reviewers'.

  • A marked-up copy of your manuscript that highlights changes made to the original version. You should upload this as a separate file labeled 'Revised Manuscript with Track Changes'.

  • An unmarked version of your revised paper without tracked changes. You should upload this as a separate file labeled 'Manuscript'.

If you would like to make changes to your financial disclosure, please include your updated statement in your cover letter. Guidelines for resubmitting your figure files are available below the reviewer comments at the end of this letter.

If applicable, we recommend that you deposit your laboratory protocols in protocols.io to enhance the reproducibility of your results. Protocols.io assigns your protocol its own identifier (DOI) so that it can be cited independently in the future. For instructions see: http://journals.plos.org/plosone/s/submission-guidelines#loc-laboratory-protocols

We look forward to receiving your revised manuscript.

Kind regards,

Jiang Gui

Academic Editor

PLOS ONE

Journal Requirements:

When submitting your revision, we need you to address these additional requirements.

1. Please ensure that your manuscript meets PLOS ONE's style requirements, including those for file naming. The PLOS ONE style templates can be found at

https://journals.plos.org/plosone/s/file?id=wjVg/PLOSOne_formatting_sample_main_body.pdf and

https://journals.plos.org/plosone/s/file?id=ba62/PLOSOne_formatting_sample_title_authors_affiliations.pdf

2. Thank you for stating the following in the Acknowledgments Section of your manuscript:

"Funding for the project was provided by the Wellcome Trust under award 076113, 085475 and 090355."

We note that you have provided funding information that is not currently declared in your Funding Statement. However, funding information should not appear in the Acknowledgments section or other areas of your manuscript. We will only publish funding information present in the Funding Statement section of the online submission form.

Please remove any funding-related text from the manuscript and let us know how you would like to update your Funding Statement. Currently, your Funding Statement reads as follows:

"No specific funding"

Please include your amended statements within your cover letter; we will change the online submission form on your behalf.

3. Thank you for stating the following in the Competing Interests section:

"The authors have declared that no competing interests exist."

We note that one or more of the authors are employed by a commercial company: SANOFI, Google.

3.1. Please provide an amended Funding Statement declaring this commercial affiliation, as well as a statement regarding the Role of Funders in your study. If the funding organization did not play a role in the study design, data collection and analysis, decision to publish, or preparation of the manuscript and only provided financial support in the form of authors' salaries and/or research materials, please review your statements relating to the author contributions, and ensure you have specifically and accurately indicated the role(s) that these authors had in your study. You can update author roles in the Author Contributions section of the online submission form.

Please also include the following statement within your amended Funding Statement.

“The funder provided support in the form of salaries for authors [insert relevant initials], but did not have any additional role in the study design, data collection and analysis, decision to publish, or preparation of the manuscript. The specific roles of these authors are articulated in the ‘author contributions’ section.”

If your commercial affiliation did play a role in your study, please state and explain this role within your updated Funding Statement.

3.2. Please also provide an updated Competing Interests Statement declaring this commercial affiliation along with any other relevant declarations relating to employment, consultancy, patents, products in development, or marketed products, etc.  

Within your Competing Interests Statement, please confirm that this commercial affiliation does not alter your adherence to all PLOS ONE policies on sharing data and materials by including the following statement: "This does not alter our adherence to  PLOS ONE policies on sharing data and materials.” (as detailed online in our guide for authors http://journals.plos.org/plosone/s/competing-interests) . If this adherence statement is not accurate and  there are restrictions on sharing of data and/or materials, please state these. Please note that we cannot proceed with consideration of your article until this information has been declared.

Please include both an updated Funding Statement and Competing Interests Statement in your cover letter. We will change the online submission form on your behalf.

Please know it is PLOS ONE policy for corresponding authors to declare, on behalf of all authors, all potential competing interests for the purposes of transparency. PLOS defines a competing interest as anything that interferes with, or could reasonably be perceived as interfering with, the full and objective presentation, peer review, editorial decision-making, or publication of research or non-research articles submitted to one of the journals. Competing interests can be financial or non-financial, professional, or personal. Competing interests can arise in relationship to an organization or another person. Please follow this link to our website for more details on competing interests: http://journals.plos.org/plosone/s/competing-interests

[Note: HTML markup is below. Please do not edit.]

Reviewers' comments:

Reviewer's Responses to Questions

Comments to the Author

1. Is the manuscript technically sound, and do the data support the conclusions?

The manuscript must describe a technically sound piece of scientific research with data that supports the conclusions. Experiments must have been conducted rigorously, with appropriate controls, replication, and sample sizes. The conclusions must be drawn appropriately based on the data presented.

Reviewer #1: Yes

**********

2. Has the statistical analysis been performed appropriately and rigorously?

Reviewer #1: Yes

**********

3. Have the authors made all data underlying the findings in their manuscript fully available?

The PLOS Data policy requires authors to make all data underlying the findings described in their manuscript fully available without restriction, with rare exception (please refer to the Data Availability Statement in the manuscript PDF file). The data should be provided as part of the manuscript or its supporting information, or deposited to a public repository. For example, in addition to summary statistics, the data points behind means, medians and variance measures should be available. If there are restrictions on publicly sharing data—e.g. participant privacy or use of data from a third party—those must be specified.

Reviewer #1: Yes

**********

4. Is the manuscript presented in an intelligible fashion and written in standard English?

PLOS ONE does not copyedit accepted manuscripts, so the language in submitted articles must be clear, correct, and unambiguous. Any typographical or grammatical errors should be corrected at revision, so please note any specific errors here.

Reviewer #1: Yes

**********

5. Review Comments to the Author

Please use the space provided to explain your answers to the questions above. You may also include additional comments for the author, including concerns about dual publication, research ethics, or publication ethics. (Please upload your review as an attachment if it exceeds 20,000 characters)

Reviewer #1: This paper is structured clearly and well written. It proposed two models for the detection of interaction effect between SNPs, of which the first one is based on the propensity scores and the second one is based on an approximation to objective function ¬\\delta\\left(x\\right).

My major concern is about the second model. A prerequisite of the second model is that the function \\delta\\left(x\\right) and d^\\star share the same support. Just as the authors said in lines 184-187, on page 7/19, “ \\delta\\left(x\\right) is half the difference between the expected phenotype , while d^\\star is the log-ratio of the same two quantities”, in other words, \\delta\\left(x\\right) is linear while d^\\star is nonlinear. Consequently, the mean function \\mu\\left(x\\right) can be cancelled from \\delta\\left(x\\right) while can not from d^\\star, which will cause the support of these two function different. The author should clarify this obscurity.

**********

6. PLOS authors have the option to publish the peer review history of their article (what does this mean?). If published, this will include your full peer review and any attached files.

If you choose “no”, your identity will remain anonymous but your review may still be made public.

Do you want your identity to be public for this peer review? For information about this choice, including consent withdrawal, please see our Privacy Policy.

Reviewer #1: Yes: Jie Zhou

[NOTE: If reviewer comments were submitted as an attachment file, they will be attached to this email and accessible via the submission site. Please log into your account, locate the manuscript record, and check for the action link "View Attachments". If this link does not appear, there are no attachment files.]

While revising your submission, please upload your figure files to the Preflight Analysis and Conversion Engine (PACE) digital diagnostic tool, https://pacev2.apexcovantage.com/. PACE helps ensure that figures meet PLOS requirements. To use PACE, you must first register as a user. Registration is free. Then, login and navigate to the UPLOAD tab, where you will find detailed instructions on how to use the tool. If you encounter any issues or have any questions when using PACE, please email PLOS at figures@plos.org. Please note that Supporting Information files do not need this step.

PLoS One. 2020 Nov 30;15(11):e0242927. doi: 10.1371/journal.pone.0242927.r003

Author response to Decision Letter 0


22 Oct 2020

Dear editor,

We sincerely thank you for managing the whole review process. We also thank the reviewer for examining our manuscript and providing interesting feedback.

We would like to transfer the exact statement we included in the acknowledgement section of our original manuscript to the funding section. We also apologize for not having clarified the commercial affiliations of some of the co-authors. The amended funding statement is the following:

"This study makes use of data generated by the Wellcome Trust Case-Control 509 Consortium. A full list of the investigators who contributed to the generation of the 510 data is available from http://www.wtccc.org.uk. Funding for the project was provided by the 511 Wellcome Trust under award 076113, 085475 and 090355.

In the form of salaries, L. S. and C. C. were supported in their research by SANOFI and JP. V. by Google. These companies did not have any additional roles in the study design, data collection and analysis, decision to publish, or preparation of the manuscript. The specific roles of these authors are articulated in the ‘author contributions’ section."

Additionally, as you suggested, our competing interests statement can be updated as follows:

"The commercial affiliations of some of the co-authors do not alter our full adherence to all PLOS ONE policies on sharing data and materials."

The rest of our manuscript now meets the journal's style guidelines. We also updated the author affiliations.

The remark of the reviewer absolutely explains the gap in performance between the modified outcome (MO) and the outcome weighted learning (OWL) approaches. In OWL, the term $d^*$ has the same sign as the term $\\delta$ in MO. The sign commonality is not sufficient to filter out the common effects term $\\mu(X)$. Despite this limitation, the OWL approach remains statistically valid, in the sense that its support recovery performance increases with the sample size (see supplementary material). In practical settings, we naturally recommend the use of the MO approaches which linearity allow a complete filtering of the term $\\mu(X)$, and consequently yield a better performance. We included this remark to our discussion section.

We remain at our disposal for any further enquiries.

Sincerely,

Lotfi Slim on behalf of all co-authors

Attachment

Submitted filename: Response to Reviewers.pdf

Decision Letter 1

Jiang Gui

12 Nov 2020

Novel methods for epistasis detection in genome-wide association studies

PONE-D-20-16158R1

Dear Dr. Slim,

We’re pleased to inform you that your manuscript has been judged scientifically suitable for publication and will be formally accepted for publication once it meets all outstanding technical requirements.

Within one week, you’ll receive an e-mail detailing the required amendments. When these have been addressed, you’ll receive a formal acceptance letter and your manuscript will be scheduled for publication.

An invoice for payment will follow shortly after the formal acceptance. To ensure an efficient process, please log into Editorial Manager at http://www.editorialmanager.com/pone/, click the 'Update My Information' link at the top of the page, and double check that your user information is up-to-date. If you have any billing related questions, please contact our Author Billing department directly at authorbilling@plos.org.

If your institution or institutions have a press office, please notify them about your upcoming paper to help maximize its impact. If they’ll be preparing press materials, please inform our press team as soon as possible -- no later than 48 hours after receiving the formal acceptance. Your manuscript will remain under strict press embargo until 2 pm Eastern Time on the date of publication. For more information, please contact onepress@plos.org.

Kind regards,

Jiang Gui

Academic Editor

PLOS ONE

Additional Editor Comments (optional):

Reviewers' comments:

Reviewer's Responses to Questions

Comments to the Author

1. If the authors have adequately addressed your comments raised in a previous round of review and you feel that this manuscript is now acceptable for publication, you may indicate that here to bypass the “Comments to the Author” section, enter your conflict of interest statement in the “Confidential to Editor” section, and submit your "Accept" recommendation.

Reviewer #1: All comments have been addressed

**********

2. Is the manuscript technically sound, and do the data support the conclusions?

The manuscript must describe a technically sound piece of scientific research with data that supports the conclusions. Experiments must have been conducted rigorously, with appropriate controls, replication, and sample sizes. The conclusions must be drawn appropriately based on the data presented.

Reviewer #1: Yes

**********

3. Has the statistical analysis been performed appropriately and rigorously?

Reviewer #1: Yes

**********

4. Have the authors made all data underlying the findings in their manuscript fully available?

The PLOS Data policy requires authors to make all data underlying the findings described in their manuscript fully available without restriction, with rare exception (please refer to the Data Availability Statement in the manuscript PDF file). The data should be provided as part of the manuscript or its supporting information, or deposited to a public repository. For example, in addition to summary statistics, the data points behind means, medians and variance measures should be available. If there are restrictions on publicly sharing data—e.g. participant privacy or use of data from a third party—those must be specified.

Reviewer #1: Yes

**********

5. Is the manuscript presented in an intelligible fashion and written in standard English?

PLOS ONE does not copyedit accepted manuscripts, so the language in submitted articles must be clear, correct, and unambiguous. Any typographical or grammatical errors should be corrected at revision, so please note any specific errors here.

Reviewer #1: Yes

**********

6. Review Comments to the Author

Please use the space provided to explain your answers to the questions above. You may also include additional comments for the author, including concerns about dual publication, research ethics, or publication ethics. (Please upload your review as an attachment if it exceeds 20,000 characters)

Reviewer #1: I think the authors have addressed my concerns and so I agree the publication of this paper on PLOS ONE.

**********

7. PLOS authors have the option to publish the peer review history of their article (what does this mean?). If published, this will include your full peer review and any attached files.

If you choose “no”, your identity will remain anonymous but your review may still be made public.

Do you want your identity to be public for this peer review? For information about this choice, including consent withdrawal, please see our Privacy Policy.

Reviewer #1: No

Acceptance letter

Jiang Gui

16 Nov 2020

PONE-D-20-16158R1

Novel methods for epistasis detection in genome-wide association studies 

Dear Dr. Slim:

I'm pleased to inform you that your manuscript has been deemed suitable for publication in PLOS ONE. Congratulations! Your manuscript is now with our production department.

If your institution or institutions have a press office, please let them know about your upcoming paper now to help maximize its impact. If they'll be preparing press materials, please inform our press team within the next 48 hours. Your manuscript will remain under strict press embargo until 2 pm Eastern Time on the date of publication. For more information please contact onepress@plos.org.

If we can help with anything else, please email us at plosone@plos.org.

Thank you for submitting your work to PLOS ONE and supporting open access.

Kind regards,

PLOS ONE Editorial Office Staff

on behalf of

Dr. Jiang Gui

Academic Editor

PLOS ONE

Associated Data

    This section collects any data citations, data availability statements, or supplementary materials included in this article.

    Supplementary Materials

    S1 File. Genotypic hidden Markov model.

    (PDF)

    S2 File. Simulation results.

    (PDF)

    Attachment

    Submitted filename: reviews PLoS.pdf

    Attachment

    Submitted filename: Response to Reviewers.pdf

    Data Availability Statement

    All relevant data are within the manuscript and its Supporting information files.


    Articles from PLoS ONE are provided here courtesy of PLOS

    RESOURCES