Skip to main content

An efficient algorithm to perform multiple testing in epistasis screening

Abstract

Background

Research in epistasis or gene-gene interaction detection for human complex traits has grown over the last few years. It has been marked by promising methodological developments, improved translation efforts of statistical epistasis to biological epistasis and attempts to integrate different omics information sources into the epistasis screening to enhance power. The quest for gene-gene interactions poses severe multiple-testing problems. In this context, the maxT algorithm is one technique to control the false-positive rate. However, the memory needed by this algorithm rises linearly with the amount of hypothesis tests. Gene-gene interaction studies will require a memory proportional to the squared number of SNPs. A genome-wide epistasis search would therefore require terabytes of memory. Hence, cache problems are likely to occur, increasing the computation time. In this work we present a new version of maxT, requiring an amount of memory independent from the number of genetic effects to be investigated. This algorithm was implemented in C++ in our epistasis screening software MBMDR-3.0.3. We evaluate the new implementation in terms of memory efficiency and speed using simulated data. The software is illustrated on real-life data for Crohn’s disease.

Results

In the case of a binary (affected/unaffected) trait, the parallel workflow of MBMDR-3.0.3 analyzes all gene-gene interactions with a dataset of 100,000 SNPs typed on 1000 individuals within 4 days and 9 hours, using 999 permutations of the trait to assess statistical significance, on a cluster composed of 10 blades, containing each four Quad-Core AMD Opteron(tm) Processor 2352 2.1 GHz. In the case of a continuous trait, a similar run takes 9 days. Our program found 14 SNP-SNP interactions with a multiple-testing corrected p-value of less than 0.05 on real-life Crohn’s disease (CD) data.

Conclusions

Our software is the first implementation of the MB-MDR methodology able to solve large-scale SNP-SNP interactions problems within a few days, without using much memory, while adequately controlling the type I error rates. A new implementation to reach genome-wide epistasis screening is under construction. In the context of Crohn’s disease, MBMDR-3.0.3 could identify epistasis involving regions that are well known in the field and could be explained from a biological point of view. This demonstrates the power of our software to find relevant phenotype-genotype higher-order associations.

Background

The complete sequence of the human genome has left scientists with rich and extensive information resources. The bloom of bioinformatics, and hence the wide availability of software, has improved the possibility to access and process genomic data. Genome-wide association (GWA) studies, using a dense map of SNPs, have become one of the standard approaches for unraveling the basis of complex genetic diseases [1]. Despite their success, only a modest proportion of currently available heritability estimates can be explained by GWA studies discovered loci [2]. Commonly performed GWA studies usually oversimplify the underlying complex problem, in that usually no account is made for the existence of multiple “small”associations and non-SNP polymorphisms, nor epigenetic effects, genetic pathways, gene-environment and gene-gene interactions [3, 4].

A lot of methods and software tools exist to perform large-scale epistasis studies [5]. These Genome-wide Association Interaction (GWAI) studies typically involve balancing between achieving sufficient power, reducing the computational burden and controlling type I error rates. Here, we present a new software tool to perform large-scale epistasis studies, using the MB-MDR methodology [6-9]. MB-MDR is a non-parametric data mining method (no assumptions are made about genetic modes of inheritance) that is able to identify interaction effects for a variety of epistasis models in a powerful way. It is able to distinguish between multiple pure interaction effects and interaction effects induced by important main effects through efficient main effects correction strategies. Apart from identifying multiple sets of significant gene-gene interactions, MB-MDR can also be used to highlight gene-environment interactions in relation to a trait of interest, while efficiently controlling type I error rates. For now, the trait can either be expressed on a binary or continuous scale, or as a censored trait. Extensions to accommodate multivariate outcomes are underway. Here, we mainly focus on second-order gene-gene interactions using bi-allelic genetic markers. However, our software can also handle multi-allelic data and categorical environmental exposure variables, as will be shown in the implementation section. Our C++ software greatly enhances MB-MDR’s first implementation as an R-package [10], both in terms of flexibility and efficiency.

Implementation

Input/Output

The essence of the MB-MDR methodology is to identify sets of gene-gene interactions via a series of association tests, which may or may not be fully non-parametric, while reducing dimensionality. Significance of the explored interactions is assessed using the maxT method [11, 12] which provides adjusted p-values by controlling for the multiple correlated tests. Then, MB-MDR prioritizes (ranks) the explored interactions via the adjusted p-values. In practical applications, there is an abundance of p-values close or equal to 1 and only a few p-values will point towards interesting multi-locus genotype combination to pursue. With this in mind, we adapt the maxT method so that it still calculates the test-statistics for all SNP pairs, but only calculates the p-values of the n best pairs, i.e. the ones with the n lowest p-values. We show that our method produces the exact same p-values as with the original maxT implementation, however using many fewer resources. When interaction signals are expected to be strong in the light of an improved study design (for instance, an increased sample size, a pathway-driven study design, the use of expression traits derived from co-expression networks) or in the context of replicating earlier epistasis findings, the value of n should be set sufficiently large by the user, in order not to lose signals in the final output. However, when epistasis is tested for in a hypotheses-free way, it is highly unlikely that more than 1000 significant epistatic pairs will be identified (n=1000, default value). Figure 1 gives a description of the input and output formats of the program.

Figure 1
figure 1

Input/output formats of MBMDR-3.0.3. MBMDR-3.0.3 takes as argument a text file (possibly converted by our software from PLINK format) containing the trait and SNP values of the subjects under study and a set of command line parameters. If the ath subject is a case (control), c a =1(0) (a=1…s). S N P b is a label referring to the bth SNP (b=1,…M). The genotype of an individual a at locus b is denoted as g a b (0 if homozygous for the first allele, 1 if heterozygous and 2 if homozygous for the second allele). The produced output is a text file containing the most significant SNP pairs in relation with the trait. (S N P l j ,S N P r j ) refers to the jth best SNP pair, i.e. the pair with the jth lowest p-value p j . Our software has only one mandatory argument: the scale of the trait. Use either −−binary for a binary trait, or −−continuous for a continuous scale, or −−survival for a censored trait (in this case the trait column is replaced by two columns, one for the time variable and one for the censoring variable). We have developed an interactive help, accessible through −−help, describing all other options. For instance, -n sets the amount of p-values to compute (default: 1000), -p sets the amount of permutations to asses statistical significance (default: 999).

New implementation of maxT

In this section, we present Van Lishout’s implementation of maxT and prove that it requires a memory proportional to n (this is: O(n) memory), whereas the classical implementation of maxT requires O(m) memory. Here, m and n refer to the number of SNP pairs and the number of top pairs to retain in the output, respectively.

The different steps of the original maxT algorithm can be decomposed as follows (see [11] for a detailed explanation of the logic behind these steps):

  1. 1.

    Compute the test-statistics for all pairs of SNPs (j=1,…,m) and sort them. The result is the Real Data vector of Figure 2 where T 0,1T 0,2≥…≥T 0,m.

Figure 2
figure 2

Classical versus Van Lishout’s implementation of maxT. In the classical maxT implementation, all Ti,j values are in memory. If only the x best p-values are envisaged then only the maximum M1,…,M B of the [T1,n+1,…,T1,m],…,[TB,n+1,…,TB,m] are needed, implying only temporary storage of the corresponding values.

  1. 2.

    Generate B random permutations of the trait column. For each permutation i=1,…,B, compute the test-statistics T i,j for all pairs of SNPs (j=1,…,m) in the order defined by the Real Data vector. Force the monotonicity of the rows: for j=m−1,…,1 replace T i,j by T i,j+1 if T i,j<T i,j+1.

  2. 3.

    For each pair of SNPs j=1,…,m compute the number a j of T i,j values such that T i,jT 0,j, for i=0,…,B.

  3. 4.

    Compute the p-values using the equation p j = a j B + 1 for each pair of SNPs. Force the monotonicity of the p-values: for j=1,…,m−1 replace p j+1 by p j if p j+1<p j .

Note that the intuition behind the monotonicity enforcing procedure at step 2 is to correct the test-statistics that are obviously too pessimistic: the test-statistic of a pair P1 should not be lower than the test-statistic of a less significant pair P2. Replacing the test-statistic computed for P1 by the one computed for P2 is therefore a better estimation of the significance of P1. The amount of false-negative results would be higher without this procedure. Similarily, the purpose of the monotonicity enforcing procedure at step 4 is to correct p-values that are obviously too optimistic: the p-value of P2 should not be lower than the p-value of P1. Replacing the p-value computed for P2 by the one computed for P1 is therefore a better estimation of the significance of P2. The amount of false-positive results would be higher without this final step.

From a memory point of view, it is best to implement the aforementioned algorithm in a slightly different way. Indeed, the current description implies all Permutation vectors of Figure 2 to be in memory at the same time. This requires O(B m) memory. In fact, a memory of O(m) can be achieved by adopting a different approach. The idea is that the a j values calculated at step 3, can already be calculated on-the-fly. A vector a-values of all a j values can be created from scratch and initialized with 1’s values. Indeed, note that at step 3 the original sample series counts as 1 of B+1 available samples to assess significance. For i=0,T0,jT0,j and hence a j =1,j=1,…,m. The elements of the a-values vector can then be updated at the end of each iteration i=1,…,B of step 2 by incrementing the a j values corresponding to the Ti,jT0,j by one. In this way, all ithTi,j values can be removed from memory at the end of the ith iteration since they are no longer of any use. Hence, only a single Permutation vector is stored instead of B vectors. In fact, applying step 4 to the a-values vector obtained at the end of this procedure readily leads to the final p-values vector.

This proves that this algorithm requires O(m) memory. Obviously, if M denotes the number of SNPs, m is given by the formula m=M(M−1)/2. The memory usage of the classical implementation thus rises quadratically with the number of SNPs, whereas we will now see that our method is independent of it.

The monotonicity enforcing process executed at the end of step 2, implies that we need to calculate all Ti,j values, even if we are only interested in the first n p-values. However, not all of these Ti,j values have to be stored in memory. For our purpose, only Ti,j(1≤jn) and M i , the maximum of the [Ti,n+1,…,Ti,m] elements, are required. In other words, there is no need to explicitly propagate M i to position n+1. It suffices to compute M i and to replace Ti,n by M i if and only if M i >Ti,n. The monotonicity enforcement continues from positions n−1 through 1.

The different steps of our algorithm, exploiting all ideas presented so far, are given below:

  1. 1.

    Compute the test-statistics for all pairs but store only the n highest ones. The result is a Real data vector where T 0,1T 0,2≥…≥T 0,n.

  2. 2.

    Initialize a vector a of size n with 1’s.

  3. 3.

    Perform the following operations for i=1,…,B:

    1. (a)

      Generate a random permutation of the trait column.

    2. (b)

      Compute the test-statistics T i,1,…,T i,n and store them in a Permutation i vector.

    3. (c)

      Compute the maximum M i of the test-statistics values T i,n+1,…,T i,m.

    4. (d)

      Replace T i,n by M i if T i,n<M i .

    5. (e)

      Force the monotonicity of the Permutation i vector: for j=n−1,…,1 replace T i,j by T i,j+1 if T i,j<T i,j+1.

    6. (f)

      For each j=1,…,n, if T i,jT 0,j increment a j by one.

  4. 4.

    Divide all values of vector a by B+1 to obtain the p-values vector p. Force monotonicity as follows: for j=1,…,n−1, replace p j+1 by p j if p j+1<p j .

Two remarks are in place:

First, the main idea of the Sorting by insertion algorithm [13] can be recycled to perform step 1 using O(n) memory. The Real Data vector is first initialized with the first n computed test-statistics and sorted using the quick sort algorithm [13]. Then, at each iteration, the next test-statistic is calculated and compared with the smallest value of the vector. If it is smaller or equal nothing has to be done. Otherwise, the smallest value is removed and the new one is inserted in order to preserve the sorting. This insertion requires n 2 operations on average. This method works particularly well on large-scale problems, where m>>n. Intuitively, the probability of having to insert will decrease at each iteration and tend to zero because the Real Data vector will contain higher and higher values. This algorithm will take O(m) time on average, but could degenerate in O(n m), which is still linear.

Second, it should be noted that step 3(b) and 3(c) can be merged into a single step. The idea is to create first a hash table containing the indexes of the n best pairs, resolving collision by separate chaining [13]. The test-statistics Ti,j can then be computed in any convenient order. At each iteration, the hash table is used to decide (almost instantaneously) if the current value corresponds to one of the n best pairs or not, and perform either step 3(b) or step 3(c) accordingly.

Parallel workflow

Since the memory used by Van Lishout’s implementation of maxT is independent from the number of SNPs, memory is no longer a problem. However, the remaining concern is time. Since all iterations of the 3rd step in the new maxT implementation are independent from each other, it is possible to simultaneously run the computations of the permutations on different machines. Figure 3 describes the three steps of the parallel workflow that we use to solve large-scale problems:

  1. 1.

    Compute the test-statistics for all pairs on one machine and save the n highest ones into a file topfile.txt. This file should be saved at a location on which each machine has read access. It will contain the information of the Real Data vector of Figure 2 and have thus a size of only O(n).

Figure 3
figure 3

MBMDR-3.0.3 parallel workflow. Step 1 of the maxT algorithm is first performed on the input file. This produce the file topfile.txt, containing the top pairs of SNPs and their corresponding test-statistics. Then, the computation of the permutations is split between the available machines. Finally, MBMDR-3.0.3 reads the produced permutation x .txt files to create the final output file.

  1. 2.

    Split the computation of the permutations homogeneously between the Z machines. On each machine z=1…Z, perform the following operations:

    1. (a)

      Read the file topfile.txt

    2. (b)

      Initialize a vector p of size n with 0’s.

    3. (c)

      Execute step 3 of Van Lishout’s maxT algorithm for each permutation assigned to z (using vector p instead of a).

    4. (d)

      Save the p vector into a file permutation z .txt.

  2. 3.

    When all machines have terminated their work, sum all vectors of the files permutation 1 .txt…permutation Z .txt to obtain a vector p. Perform step 4 of Van Lishout’s maxT algorithm on this vector.

However, the main feature that makes our software fast is not parallelization, but speed of the test-statistic computations. Indeed, we have seen that the maxT algorithm computes B×mT i,j values. Solving B=999 permutations with a dataset of M=100,000 SNPs, i.e. m=O(1010) pairs of SNPs, means thus O(1013) computations to perform. It is obvious that the computation of the test-statistic T i,j has to be very fast and that each improvement can have a dramatic influence on the final computing time. We show in the next section how we achieve this goal.

Test-statistic computation

This section presents the implementation of the computation of the T i,j values, capturing the degree of association between the jth pair of SNPs [SNP lj ,SNP rj ] and the ith permutation of the trait Trait i . Let M+1 (n+1) be the number of possible values for SNP lj (SNP rj ). In practice, most of the studies concern bi-allelic genetic markers and M=N=2. However, our program automatically detects the exact values of M and N, so that multi-allelic variables are also covered. Furthermore, categorical environment variables can also be handled, as long as they are coded 0, 1,... M (N).

Since we are interested in solving large-scale problems, we must realize that the part of the code that reads the dataset at the start of the program cannot store it in cache because of its size. Accessing to the trait and SNP values is thus slow and must be avoided as much as possible. For this reason, the three columns of interest (Trait i , SNP lj and SNP rj ) will be passed by value and not by reference to the function. In this way, an explicit local copy of them will be performed, on which the function will be able to work faster.

Different options are implemented at the different steps of the computation of T i,j , depending on the nature of the trait (e.g. [8, 14, 15]). Figure 4 illustrates the three main steps involved in the statistics computations, in the case of a case-control or cohort design and a binary (affected/unaffected) trait, without adjusting for main effect, speeding up the computation time. Similar mechanisms hold for other MB-MDR eligible scenario’s.

  1. 1.

    Generation of the affected-subjects and unaffected-subjects matrices. These matrices are easily obtained by performing a loop over the subjects of the dataset: for a=1,…n, if c a =1 increment a cell of the affected-subjects matrix, else a cell of the unaffected-subjects matrix. The cell to be incremented depends on the genotype: g alj indicates which row of the matrix has to be incremented and g arj which column.

Figure 4
figure 4

Decomposition of the different steps of the computation of T i,j . c a is 1 (0) if the ath subject is a case (control) for the ith permutation of the trait. g alj and g arj are 0, 1 or 2 depending on the genotype of the ath subject for the jth pair. A mn and U mn are respectively the number of affected/unaffected subjects, whose genotype g kl = m and g kr = n. R mn is either “H” if the subjects whose genotype is m for SNP lj and n for SNP rj have a high statistical risk of disease, “L” if they have a low statistical risk and “O” if there is no statistical evidence.

  1. 2.

    Generation of the HLO-matrix from the two matrices generated at step 1. The value of each R mn elements depends on a test for association between the trait and the genotype (SNP lj = m, SNP rj = n). This can be a χ 2 test with one degree of freedom in the case of a binary trait, an F-test in the case of a continuous trait, a log-rank test in the case of survival data. However, the architecture of the software makes it easy to implement other test statistics that are appropriate for the data at hand. For binary traits, the implemented test statistic is defined by ( ad bc ) 2 ( a + b + c + d ) ( a + b ) ( c + d ) ( b + d ) ( a + c ) , where a and b refer to the number of affected and unaffected subjects having the genotype (SNP lj = m, SNP rj = n) and c and d refer to the number of affected and unaffected subjects having a different genotype. This statistic follows a χ 2 distribution. If we define N A and N U to be the total number of affected and unaffected subjects, those values are easy to compute: a = A mn ,b = U mn ,c = N A −A mn and d = N U −U mn . At this point, if either a+b or c+d is below a threshold that is a parameter of the program (default value 10) then the test is not performed at all, since it would not be statistically significant. In this case the value of R mn will be set to “O”, to indicate the absence of evidence that the subset of individuals with multilocus genotype (SNP lj = m, SNP rj = n) has neither a high nor a low risk for disease. Otherwise, the test is performed. When the computed χ 2 value is not significant based on a liberal significance threshold of 0.1 (default value in the software), the value of R mn will be set to “O”, to indicate that we cannot reject the independence hypothesis. Otherwise, R mn will be set to either “H” if (ad−bc)>0, to indicate that the population whose genotype is (SNP lj = m, SNP rj = n) has a high risk of having the trait, or to “L” if (ad−bc)<0, to indicate a low risk for this event.

  2. 3.

    Computation of T i,j from the three matrices generated at step 1 and 2. It consists in performing two χ 2 tests with one degree of freedom and returning the maximum of both. The first one tests association between the trait and the belonging to the “H” category versus the “L” or “O” category. The second one tests association between the trait and the belonging to the “L” category versus the “H” or “O” category. In the first (second) case, a and b are respectively the number of affected and unaffected subjects belonging to the “H” (“L”) category and c and d to the “L” (“H”) or “O” category. Computing this can be easily achieved by initializing a,b,c and d to zero, and for each R mn adding A mn to a and U mn to b if R mn = “H” (“L”) and A mn to c and U mn to d otherwise.

In summary, this paragraph shows that to make this methodology fast, reading the data of the subjects only once during step 1 to create the affected-subjects and unaffected-subjects matrices is a key. In this way, the test statistic computation function can quickly start to work on a very small part of memory that is in cache. The keys that make step 2 and 3 fast are respectively the fact that computing an R mn value does not require any loop and the fact that a single loop of nine iterations (in the bi-allelic case) allows to calculate all the numbers needed in the χ2 formula.

Results and discussion

Here we present results for both simulated data and real-life data.

Simulated data

In order to assess the speed performances of our C++ software MBMDR-3.0.3, we created 4 different datasets with 1,000 individuals each, of respectively 100 SNPs, 1,000 SNPS, 10,000 SNPs and 100,000 SNPs. To assess significance of MB-MDR results, the number of permutations was set to B=999. Each dataset was constructed to contain a strong signal for the functional pair [SNP 5 ,SNP 10 ]. Table 1 states the two-locus penetrance table used to generate the data. A balanced number of cases and controls is sampled. The minor allele frequencies of the functional SNPs were fixed at 0.5 and those of the non-functional SNPs were generated randomly from a uniform distribution on [0.05, 0.5]. This corresponds to the first of six purely epistatic models discussed in [16]. A similar strategy was used to construct another set of 4 datasets, containing the same number of individuals and SNPs as before, but expressing the trait on a continuous scale instead of a binary one. MBMDR-3.0.3 finds the strong signal in all datasets. Table 2 gives the execution times. Since the parallel workflow of MBMDR-3.0.3 was tested on a cluster composed of 10 blades, containing each four Quad-Core AMD Opteron(tm) Processor 2352 2.1 GHz, the computation of the permutations was split between 10×4×4=160 cores for this experiment. Table 2 shows that our software is about two times faster for solving datasets for which the trait is expressed on a binary scale, compared to datasets where the trait is expressed on a continuous one. Finally, the results in Table 2 also show that the execution time is approximately multiplied by 100 when the number of SNPs is multiplied by 10. This is logical, since the computation time mainly depends on how many test-statistics are computed, which in turn depends on the quantity of pairs of SNPs, which is proportional to the squared number of SNPs.

Table 1 Two-locus penetrance table used to create the strong signal
Table 2 Execution times of MBMDR-3.0.3

Crohn’s disease data

We apply our software to real-life data on Crohn’s disease [17][18]. Here, Caucasian Crohn’s disease patients and healthy controls are genotyped using Illumina HumanHap. Quality control tests are performed on these data excluding SNPs and individuals with more than 5% missing genotypes. Individuals with mean heterozygosity outside the range of 31% to 38% are discarded. The gender of the individuals is predicted from the mean homozygosity on X markers and samples with contradiction between the estimated and the recorded gender are excluded. SNPs violating Hardy-Weinberg principle are discarded using aχ p-value threshold of 10−4. Related individuals are identified using pairwise IBS tests and discarded as well. The cleansing process give rise to a set of 1687 unrelated Caucasians (676 CD patients and 1011 healthy controls) and 311,192 SNPs.

For the purpose of this study, we use Biofilter.0.5.1 [19] as an additional data preparation step. It uses a knowledge-driven approach to prioritize genetic markers in gene-gene interaction screening while reducing the search space. In particular, Biofilter allows the explicit detection and modeling of interactions between a large set of SNPs based on biological information about gene-gene relationships and gene-disease relationships. The knowledge-based support for the models is attributed by implication index, which is simply a number of data sources that provide evidence of gene-gene interaction or gene-disease relationship, and is calculated by summing the number of data sources supporting each of the two genes and the connection between them (see [19] for more details). In practice, to make the prioritization procedure in Biofilter more focused on CD, we apply a list of candidate genes for CD (120 genes collected from the publications [18][20][23]) and 160 groups (collected basing on selective search in Biofilter using keywordscrohn, enteritis, inflam, autoimmune, immune, bowel, gastrointest, ileum, ileitis, intestine, lleocolic, diarrhea, stenosis and cytokine). Using this approach/analysis we ended up with 12,471 SNPs that we further analyze in MB-MDR.

Table 3 lists all the MBMDR-3.0.3 statistically significant interactions for the Crohn’s disease data under investigation. Note that these results are adjusted for testing about 77 million pairs of SNPs. Table 4 shows the genomic location of SNPs involved in these interactions. A total of 13 out of 14 significant interactions involves rs11209026 or rs11465804. Both SNPs are located in the interleukin-23 receptor (IL23R) gene, a known susceptibility gene for CD. The SNP rs11209026 is a non-synonymous coding SNP (Arg381Gln substitution), while rs11465804 is intronic and in strong linkage disequilibrium (LD) with rs11209026 (r2 = 0.97). In the original GWA studies, these two SNPs gave the most significant association signals with p < 10 −9. Given the strong correlation between the SNPs, it is to be expected that all interactions found for one SNP are also found for the other (Table 3). The most significant interaction is between rs11209026 and rs7573680 (p=0.004). The latter is an intronic SNP located in HDAC4 (histone deacetylase 4). Figure 5 shows a synergy disequilibrium plot [24] for the SNPs listed in Table 3. Such a plot is able to highlight disease-associated haplotypes, as well as epistatically interacting loci with respect to disease. Interestingly, when we adjust the MB-MDR screen for main effects [9], no significant SNP pair is relevant.

Table 3 SNP-SNP interactions having a multiple testing corrected p-value < 0.05
Table 4 Location of the SNPs involved in a significant SNP-SNP interaction
Figure 5
figure 5

SD plot. Synergy Disequilibrium (SD) plot of potential epistasis interactions between the loci indicated in Table 3

Discussion

Several studies have suggested that different signals exist in IL23R, conferring risk or protection to Crohn’s disease. A study by Taylor et al[25], where they aimed to estimate the total contribution of the IL23R gene to CD risk using a haplotype approach, showed that the population attributable risk for these haplotypes was substantially larger than that estimated for the IL23R Arg381Gln variant alone. MBMDR-3.0.3 identified several “epistatic” signals from pairs of SNPs located in the IL23R gene. It should be noted though that epistasis signals on SNPs in LD are considered to be non-synergetic. The MB-MDR discoveries on Crohn’s disease also seem to give us a new working hypothesis to expand on the current knowledge (histone deacetylation). Indeed, histone deacetylation results in a compact chromatin structure commonly associated with repressed gene transcription (epigenetic repression), and hereby plays a critical role in transcriptional regulation, cell cycle progression and developmental events. Although not known to physically interact directly, IL23R and HDAC4 could be linked trough MAPK1/STAT3 signaling: MAPK1 has been shown to associate with phosphorylate HDAC4 [26]. Protein phosphorylation regulates the corepressor activity of the deacetylase. MAPK1 also acts as an important activator of STAT3 (signal transducer and activator of transcription 3) which is an essential regulator of immune-mediated inflammation. In addition, the IL23/IL23R pathway modulates STAT3 transcriptional activity, and recently it has been shown that CD8+ T cells from Arg381Gln IL23R carriers showed decreased STAT3 activation compared with WT CD8+ T cells [27]. It can thus be hypothesized that a balanced action between the HDAC1/MAPK1 and IL23/IL23R pathways, converging on STAT3 signaling, are important for CD pathogenesis. The fact that no significant SNP pairs remain, following an adjustment of the MB-MDR screen for main effects (an observation that already emerged after interpreting Figure 5) seems to suggest that the significant results for the SNP pairs of Table 3 are mainly induced by important main effect players.

MBMDR-3.0.3 can accommodate a variety of study designs and outcome types, can correct for important lower order effects and satisfactory deals with the computational burden induced by highly-dimensional complex data. In order to upscale the applicability of the MB-MDR methodology towards genome-wide association interaction analyzes, the method was implemented in C++ and a new version of the maxT algorithm was incorporated. This version requires an amount of memory that is independent from the number of genetic effects to be investigated. We were able to further reduce the execution time, first by parallelizing the processes and second by optimizing the test-statistic function capturing the degree of association between a pair of SNPs and a trait. All of these features, available in MBMDR-3.0.3, are promising in the light of GWAI studies. Alternative approaches to deal with execution time are proposed, for example GPU [28] and cloud computing [29]. Used in conjunction with MB-MDR, those methods could lead to very fast software tool to solve GWAI studies problems.

Conclusions

In this paper we have presented the epistasis screening software MBMDR-3.0.3. It is based on a new implementation of maxT. The main advantage of this improvement, is that it solves memory problems for any kind of analysis by becoming independent from the number of SNPs, without loss of power. We have also presented a fast implementation of a test-statistic function indicating the association between the trait and a pair of SNPs.

We have tested our program on simulated datasets of increasing size. The parallel workflow was tested on a cluster composed of 10 blades, containing each four Quad-Core AMD Opteron(tm) Processor 2352 2.1 GHz and is able to analyze all pairwise gene-gene interactions with a dataset of 100,000 SNPs typed on 1000 individuals within 4 days and 9 hours, using 999 permutations of the trait to assess statistical significance.

Availability and requirements

  • Project name: MB-MDR

  • Project home page: http://www.statgen.ulg.ac.be

  • Operating system(s): Mac OS X and Linux

  • Programming language: C++

  • Restrictions on use by non-academics: no limitations

References

  1. Hardy J, Singleton A: Genome-wide association studies and human disease. N Engl J Med. 2009, 360: 1759-1768. 10.1056/NEJMra0808700.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  2. Manolio TA, Collins FS, Goldstein DB, Hindorff LA, Hunter DJ, McCarthy MI, Ramos EM, Cardon LR, Chakravarti A, Cho JH: Finding the missing heritability of complex diseases. Nature. 2009, 461 (7265): 747-753. 10.1038/nature08494.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  3. Visscher PM, Brown MA, McCarthy MI, Yang J: Five years of GWAS discovery. Am Soc Hum Genet. 2012, 90: 7-24. 10.1016/j.ajhg.2011.11.029.

    Article  CAS  Google Scholar 

  4. Zuk O, Hechter E, Sunyaev SR, Lander ES: The mystery of missing heritability: genetic interactions create phantom heritability. Proc Natl Acad Sci. 2012, 109 (4): 1193-1198. 10.1073/pnas.1119675109.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  5. Van Steen K: Traveling the world of gene-gene interactions. Brief Bioinform. 2011, 13: 1-19.

    Article  Google Scholar 

  6. Calle ML, Urrea V, Malats N, Van Steen K: MB-MDR: model-based multifactor dimensionality reduction for detecting interactions in high-dimensional genomic data. Tech. Rep. 24, Department of Systems Biology, Universitat de Vic, Vic,: Spain; 2008

  7. Calle ML, Urrea V, Vellalta G, Malats N, Van Steen K: Improving strategies for detecting genetic patterns of disease susceptibility in association studies. Stat Med. 2008, 27: 6532-6546. 10.1002/sim.3431.

    Article  CAS  PubMed  Google Scholar 

  8. Cattaert T, Calle ML, Dudek SM, Mahachie John JM, Van Lishout F, Urrea V, Ritchie MD, Van Steen K: Model-based multifactor dimensionality reduction for detecting epistasis in case-control data in the presence of noise. Ann Hum Genet. 2011, 75: 78-89. 10.1111/j.1469-1809.2010.00604.x.

    Article  PubMed Central  PubMed  Google Scholar 

  9. Mahachie John JM, Cattaert T, Van Lishout F, Gusareva E, Van Steen K: Lower-order effects adjustment in quantitative traits model-based multifactor dimensionality reduction. PLoS ONE. 2012, 7 (1): e29594-10.1371/journal.pone.0029594. http://dx.doi.org/10.1371/journal.pone.0029594,

    Article  PubMed Central  PubMed  Google Scholar 

  10. Calle ML, Urrea V, Malats N, Van Steen K: mbmdr: an R package for exploring gene-gene interactions associated with binary or quantitative traits. Bioinformatics. 2010, 26 (17): 2198-2199. 10.1093/bioinformatics/btq352.

    Article  CAS  PubMed  Google Scholar 

  11. Ge Y, Dudoit S, Speed TP: Resampling-based multiple testing for microarray data analysis. Tech. Rep. 633, Department of Statistics: University of California, Berkley; 2003

  12. Westfall PH, Young SS: Resampling-base Multiple Testing. 1993, New York: Wiley

    Google Scholar 

  13. Knuth D: The Art of Computer Programming, Volume 3: Sorting and Searching, Second Edition. 1998, Addison-Wesley: Reading

    Google Scholar 

  14. Cattaert T, Urrea V, Naj AC, De Lobel L, De Wit V, Fu M, Mahachie John JM, Shen H, Calle ML, Ritchie MD: FAM-MDR: A Flexible family-based multifactor dimensionality reduction technique to detect epistasis using related individuals. PLoS ONE. 2010, 5 (4): e10304-10.1371/journal.pone.0010304. http://dx.doi.org/10.1371/journal.pone.0010304,

    Article  PubMed Central  PubMed  Google Scholar 

  15. Mahachie John JM, Van Lishout F, Van Steen K: Model-based multifactor dimensionality reduction to detect epistasis for quantitative traits in the presence of error-free and noisy data. Eur J Hum Genet. 2011, 19 (6): 696-703. 10.1038/ejhg.2011.17.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  16. Ritchie MD, Hahn LW, Moore JH: Power of multifactor dimensionality reduction for detecting gene-gene interactions in the presence of genotyping error, missing data, phenocopy, and genetic heterogeneity. Genet Epidemil. 2003, 24 (2): 150-157. 10.1002/gepi.10218.

    Article  Google Scholar 

  17. Libioulle C, Louis E, Hansoul S, Sandor C, Farnir F, Franchimont D, Vermeire S, Dewit O, de Vos M, Dixon A: Novel Crohn disease locus identified by genome-wide association maps to a gene desert on 5p13.1 and modulates expression of PTGER4. PLoS Genet. 2007, 3 (4): e58-10.1371/journal.pgen.0030058.

    Article  PubMed Central  PubMed  Google Scholar 

  18. Barett JC, Hansoul S, Nicolae DL, Cho JH, Duerr RH, Rioux JD, Brant SR, Silverberg MS, Taylor KD, Barmada MM: Genome-wide association defines more than 30 distinct susceptibility loci for Crohn’s disease. Nat Genet. 2008, 40 (8): 955-962. 10.1038/ng.175.

    Article  Google Scholar 

  19. Bush WL, Dudek SM, Ritchie MD: Biofilter: a knowledge-integration system for the multi-locus analysis of genome-wide association studies. Pacific Symposium on Biocomputing. 2009, 368-379. [http://www.ncbi.nlm.nih.gov/pmc/articles/PMC2859610/pdf/nihms186228.pdf]

    Google Scholar 

  20. Raychaudhuri S, Plenge RM, Rossin E, Ng AC, Consortium IS, Purcell SM, Sklar P, Scolnick EM, Xavier RJ, Altshuler D: Identifying relationships among genomic disease regions: predicting genes at pathogenic SNP associations and rare deletions. PLoS Genet. 2009, 5 (9): 1-15.

    Google Scholar 

  21. Franke A, McGovern DP, Barrett JC, Wang K, Radford-Smith G, Ahmad T, Lees CW, Balschun T, Lee J, Roberts R: Genome-wide meta-analysis increases to 71 the number of confirmed Crohn’s disease susceptibility loci. Nat Genet. 2010, 42 (12): 1118-1126. 10.1038/ng.717.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  22. Kaser A, Zeissig S, Blumberg RS: Inflammatory bowel disease. Annu Rev Immunol. 2010, 28: 573-621. 10.1146/annurev-immunol-030409-101225.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  23. Dalal SR, Kwon HK: The role of MicroRNA in inflammatory bowel disease. Gastroenterol Hepatol. 2010, 6: 714-722.

    Google Scholar 

  24. Watkinson J, Anastassiou D: Synergy disequilibrium plots: graphical visualization of pairwise synergies and redundancies of SNPs with respect to a phenotype. Bioinformatics. 2009, 25 (11): 1445-1446. 10.1093/bioinformatics/btp159.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  25. Taylor KD, Targn SR, Mei L, Ippoliti AF, McGovern D, Mengesha E, King L, Rotter JI: IL23R Haplotypes provide a large population attributable risk for Crohn’s disease. Inflamm Bowel Dis. 2008, 14 (9): 1185-1191. 10.1002/ibd.20478.

    Article  PubMed Central  PubMed  Google Scholar 

  26. Zhou X, Richon VM, Wang AH, Yang XJ, Rifkind RA, Marks PA: Histone deacetylase 4 associates with extracellular signal-regulated kinases 1 and 2, and its cellular localization is regulated by oncogenic Ras. Proc Natl Acad Sci USA. 2000, 97: 14329-14333. 10.1073/pnas.250494697.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  27. Sarin R, Wu X, Abraham C: Inflammatory disease protective R381Q IL23 receptor polymorphism results in decreased primary CD4+ and CD8+ human T-cell functional responses. Proc Natl Acad Sci USA. 2011

    Google Scholar 

  28. Sinnott-Armstrong NA, Greene CS, Cancare F, Moore JH: Accelerating epistasis analysis in human genetics with consumer graphics hardware. BMC Res Notes. 2009, 2: 149-10.1186/1756-0500-2-149.

    Article  PubMed Central  PubMed  Google Scholar 

  29. Wang Z, Wang Y, Tan KL, Wong L, Agrawal D: CEO: a cloud epistasis computing model in GWAS. International Conference on Bioinformatics & Biomedicine; Hong Kong. 2010, [http://ieeexplore.ieee.org/stamp/stamp.jsp?tp=&arnumber=5706522]

    Google Scholar 

Download references

Acknowledgements

This paper presents research results of the Belgian Network DYSCO (Dynamical Systems, Control, and Optimization), funded by the Interuniversity Attraction Poles Programme, initiated by the Belgian State, Science Policy Office. The scientific responsibility rests with its author(s). Their work was also supported in part by the IST Programme of the European Community, under the PASCAL2 Network of Excellence (Pattern Analysis, Statistical Modelling and Computational Learning), IST-2007-216886. FVL, LW and KVS also acknowledges support by Alma in Silico, funded by the European Commission and Walloon Region through the Interreg IV Program. For MC and VU, this work was partially supported by Grant MTM2008-06747-C02-02 from el Ministerio de Educación y Ciencia (Spain), Grant 050831 from La Marató de TV3 Foundation, Grant 2009SGR-581 from AGAUR-Generalitat de Catalunya. VU is the recipient of a pre-doctoral FPU fellowship award from the Spanish Ministry of Education (MEC). We would like to thank Tom Cattaert (former post-doc) for the interesting discussions and help on further improving the software.

Author information

Authors and Affiliations

Authors

Corresponding authors

Correspondence to François Van Lishout or Kristel Van Steen.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors’ contributions

FVL had the original idea of the new maxT algorithm and LW helped actively on its formalization. FVL is the developer of all versions of our C++ software, from MBMDR-1.0.0 to MBMDR-3.0.3 and the principal author of the manuscript. VU and JM took an active role in the analysis part of the software development. JM and EG tested the program intensively on both simulated and real-life datasets. ET and BC performed the quality control of the Crohn’s disease real-life dataset and EG used Biofilter to select a subset of interesting SNPs from it. IC is the main contributor of the discussion paragraph on the Crohn’s disease results. KVS, MC and VU were engaged in all stages of the project. All authors read and approved the final manuscript.

Authors’ original submitted files for images

Rights and permissions

This article is published under license to BioMed Central Ltd. This is an Open Access article distributed under the terms of the Creative Commons Attribution License (http://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

Lishout, F.V., Mahachie John, J.M., Gusareva, E.S. et al. An efficient algorithm to perform multiple testing in epistasis screening. BMC Bioinformatics 14, 138 (2013). https://doi.org/10.1186/1471-2105-14-138

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-14-138

Keywords