Abstract

Standard normal statistics, chi-squared statistics, Student’s t statistics and F statistics are used to map quantitative trait nucleotides for both small and large sample sizes. In genome-wide association studies (GWASs) of single-nucleotide polymorphisms (SNPs), the statistical distributions depend on both genetic effects and SNPs but are independent of SNPs under the null hypothesis of no genetic effects. Therefore, hypothesis testing when a nuisance parameter is present only under the alternative was introduced to quickly approximate the critical thresholds of these test statistics for GWASs. When only the statistical probabilities are available for high-throughput SNPs, the approximate critical thresholds can be estimated with chi-squared statistics, formulated by statistical probabilities with a degree of freedom of two. High similarities in the critical thresholds between the accurate and approximate estimations were demonstrated by extensive simulations and real data analysis.

Introduction

In genome-wide association studies (GWASs), multiple testing is required to identify quantitative trait nucleotides (QTNs) with a large number of test statistics to establish an association between single-nucleotide polymorphisms (SNPs) and quantitative traits [1]. Some multiple testing approaches, such as the Bonferroni adjustment [2], permutation test [3], Bonferroni step-down adjustment [4] and Benjamini–Hochberg correction [5], are available to reduce the high false discovery rate (FDR) caused by testing each SNP individually. As the most popular method for multiple testing, the Bonferroni correction raises the significance threshold to α/m in the presence of m independent tests at a significance level of α. However, overcorrection of the significance threshold with the number of SNPs in place of m makes the Bonferroni correction more stringent and conservative for the tested SNPs in a linkage disequilibrium. A number of attempts [6–14] have been made to extend the Bonferroni correction procedure to handle correlated tests by estimating the effective number of independent markers. As an accurate adjustment for multiple testing, the permutation test appropriately takes into account the marker dependency. While this results in a more powerful test [15], this method is too expensive computationally. Compared to Bonferroni corrections and permutation tests that simultaneously modify all tests, the Bonferroni step-down adjustment and Benjamini–Hochberg correction individually correct each test for SNPs, by providing different significance thresholds, according to the order of the corresponding statistical probabilities of the SNPs. Given that the significance thresholds are dependent on the number of SNPs, both of these multiple testing approaches may become more conservative when testing the large numbers of SNPs that have been identified with the recent advances in sequencing technology [16].

In linkage analysis, Piepho [17] has introduced hypothesis testing for the situation when the nuisance parameter is present only under the alternative [18, 19] to quickly approximate thresholds for chi-squared test statistics for quantitative trait loci detection. Notably, this method provides nearly identical results as the permutation test. In fact, in addition to standard normal statistics or chi-squared statistics, Student’s t or F statistics are often constructed to test the significance of the genetic effects of SNPs in a small sample set during the first stage of a two-stage GWAS design. In this study, we extend Piepho’s quick approximation of critical thresholds for linkage analysis to GWASs, based on chi-squared statistics. Moreover, the critical thresholds for standard normal, Student’s t and F statistics can also be estimated by the quick approximations proposed by Davies et al. [20]. We can derive the approximation of critical thresholds for P-values following Fisher’s argument when only the corresponding statistical probability P-values are available for the tested SNPs, regardless of the type of test statistics used [21].

Method

To map QTNs with a GWAS, standard normal statistics (U) or chi-squared statistics (⁠|${\chi}^2$|⁠) with 1 degree of freedom (df) (theoretically |${\chi}^2={U}^2$|⁠) are often formulated from large samples, whereas F statistics with df = p and q (⁠|$F={t}^2$| at p = 1) and Student’s t statistics with df = 1 are generally constructed from small samples. The distributions of these statistics depend on both genetic effects and SNPs. However, the distributions are independent of SNPs when there are no genetic effects, such that the statistics cannot be directly applied to infer the significance of the genetic effects. For a null hypothesis (the genetic effect is zero) when the nuisance parameter (SNP) is present only under the alternative (the genetic effect is not zero), Davies [18–20] sequentially derived the test from the U, |${\chi}^2$|⁠, F or t statistics, depending on the SNP, and provided an upper bound for the type I error rate. Further, the upper bound was evaluated quickly using the approximate critical threshold.

Threshold values based on test statistics

The values of the U, |${\chi}^2$|⁠, F or t statistics were calculated by the phenotype observed and m high-throughput SNPs genotyped from n individuals, which were denoted as Ui, |${\chi}_i^2$|⁠, Fi or ti, respectively, for i = 1, 2, …, m. The critical threshold (T) for the type I error rate (α) was estimated by the following:
for the U statistic, where |$\mathrm{V}={\sum}_{i=1}^m\left|{U}_i-{U}_{i-1}\right|$|⁠,
for the |${\chi}^2$| statistic, where |$\mathrm{V}={\sum}_{i=1}^m\left|\sqrt{\chi_i^2}-\sqrt{\chi_{i-1}^2}\right|$|⁠,
for the F statistic, where |$u=\frac{T}{T+{d}f}$|⁠, |$\mathrm{V}={\sum}_{i=1}^m\Bigg|\arctan \sqrt{\frac{F_i}{{d}f}}-\arctan \sqrt{\frac{F_{i-1}}{{d}f}}\Bigg|$|
for the t statistic, where |$u=\frac{T^2}{T^2+{d}f}$| and |$\mathrm{V}={\sum}_{i=1}^m\Bigg|\arctan \left(\frac{t_i}{\sqrt{{d}f}}\right)-\arctan \left(\frac{t_{i-1}}{\sqrt{{d}f}}\right)\Bigg|$|⁠.

After solving the above equations, the critical thresholds can be determined by numerical methods.

Threshold values based on P-values

When only the P-values are available for high-throughput SNPs, the critical thresholds can also be estimated approximately using |${\chi}^2$| statistics, formulated by the statistical probabilities of the SNPs [21].

If the genetic effect is hypothesized as zero, the P-values can be considered as a realization of a random variable P that is uniformly distributed on [0, 1], i.e. whose density function is the following:
If we let |$Y=-21\mathrm{n}\,\kern0.1em P$|⁠, then under the hypothesis, the density function of Y is given by
which is the density function of a chi-squared distribution with df = 2.
Using |${\chi}^2$| in place of Y, the critical threshold T for the type I error rate α can be estimated by

Implementation

The approximate calculation of critical thresholds can be easily implemented by the R statistical language (https://www.r-project.org/). Using test statistic values or P-values from the positions of the SNPs within the genome, we first calculated V by the diff() function and then wrote pr() of the critical thresholds c with pnorm(-c, lower.tail = F) for the U statistics, pchisq(c, df, lower.tail = F) for the |${\chi}^2$| statistics, pf(c,1, df, lower.tail = F) for the F statistics and pt(c, df, lower.tail = F) for the t statistics.

Using V and pr(), the function subroutines were designed based on the corresponding equations for the critical thresholds c as follows.

For the U statistic, fun <- function(c){pnorm(-c, lower.tail = F) +V*exp(–0.5*c^2)/sqrt(8*pi)-alpha}; for the |${\chi}^2$| statistic, pchisq(c, df, lower.tail = F) + V*exp(–0.5*c)/sqrt(2)/gamma(0.5)-alpha}. For the F statistic, pf(c, df1, df2, lower.tail = F) + V*u^(0.5*(df1-1))*(1-u)^(0.5*(df2-1))*gamma(0.5*(df1 + df2))/gamma(0.5*df1)/gamma(0.5*df2)-alpha} and for the t statistic, pt(c,df,lower.tail = F) + V*(1-u)^(0.5*(df - 1))*gamma(0.5*(df + 1))/(2*sqrt(pi))/gamma(0.5*df)-alpha}.

fun can be solved with the nleqslv() function below.

Threshold <- nleqslv(fun, c(min(test statistic values), max(test statistic values))). Thus, threshold c <- Threshold$x.

The R code can be organized into a single module, namely the following:

threshold <- function(StatisticUsed, alpha, StatisticValues),

where StatisticUsed <- c(‘U’, ‘t’, ‘Chi-square’, ‘F’, ‘P-value’), alpha <- c(0.05,0.01) and StatisticValues <- c(U, t, Chi-square, F, P-value).

In the implementation, we can specify any one option for the StatisticUsed to evaluate the thresholds related to both the 0.05 and 0.01 significance levels. The codes have been provided in the supplementary files.

Simulations

Using a Wright’s FST value of 0.012 to specify the heterozygosity of the genetic markers [22], the marker genotype data for a single population were simulated based on the Balding–Nichols model [23]. We performed three simulation experiments to investigate the following: (i) the effects of the statistic choice on the approximate thresholds by designating population sizes of 50, 100, 200, 500, 1000 and 2000, for the 100 000 simulated SNPs; (ii) the effects of the number of markers on the approximate thresholds by simulating 10 000, 50 000, 100 000 and 500 000 SNPs for the population sizes of 100 and 2000; and (iii) the robustness of the quick approximation methods for non-normality by generating phenotypes with uniform distribution U(1.5,10) and chi-squared distribution |${\chi}^2$| (iii) for the population sizes of 100, 200, 1000 and 2000 for the 100 000 simulated SNPs. It should be noted that in simulations (i) and (ii), the phenotypes were randomly generated from the normal distribution N(0, 6) with the same variance as the uniform and chi-squared distributions in simulation (iii). For the simulated population without stratification, each statistic for the null hypothesis of no QTN was computed using a simple linear regression of the phenotype to the markers. The simulations were repeated 1000 times to evaluate the quick approximation of the critical thresholds. Accurate critical thresholds were calculated by 1000 permutation tests. The 95% and 99% confidence intervals of the accurate critical thresholds were obtained from the orders of the statistics of the permutation distribution [24]. Quick approximation, Bonferroni step-down adjustment and Benjamini–Hochberg correction were compared to evaluate the approximate critical thresholds. Given the significance levels of 0.01 and 0.05, we also assessed the empirical type I error rates of the competing methods, which were recorded as the percentage that rejected the null hypothesis.

 Q–Q plots for six different population sizes for 100 000 simulated SNPs: (a) population size of 50, (b) 100, (c) 200, (d) 500, (e) 1000 and (f) 2000.
Figure 1

Q–Q plots for six different population sizes for 100 000 simulated SNPs: (a) population size of 50, (b) 100, (c) 200, (d) 500, (e) 1000 and (f) 2000.

Figure 1 showed the six Quantile–Quantile (Q–Q) plots of the genome from the first simulation. The P-values of the statistics used fit well with the expected distribution, and severe inflation was observed for a small number of markers with high P-values. This suggested that population stratification did not occur in the simulated genome, and the type I error rates were well-controlled for the six different population sizes. The approximate and accurate critical threshold values of –log10(p) from the 1st simulation are listed in Table 1 (of statistics in Table S1 of supplementary file). Overall, for Student’s t statistic of the small population and U and chi-squared statistics, all the approximate thresholds fell within the confidence intervals of the permutations. When the population size was less than 200, the approximate thresholds for the t statistics approached the accurate thresholds of the permutations and well-controlled FDRs, while there were considerable differences between the approximate and accurate thresholds for U and chi-squared statistics. For the large population, the approximate thresholds of the U statistics were close to the lower bounds, whereas those of the chi-squared were close to the upper limits of the confidence intervals. In the simulation, the Bonferroni step-down adjustment obtained almost the same thresholds as the Bonferroni correction (6.301 and 7.000 at significance levels of 0.05 and 0.01, respectively), while Benjamini–Hochberg correction underestimated the thresholds compared to the Bonferroni correction. In contrast, the quick approximation gave lower and higher threshold estimates for the t or U and chi-squared or P-value statistics, respectively, than the Bonferroni correction, Bonferroni step-down adjustment and Benjamini–Hochberg correction. The empirical type I error rates generally declined as the critical thresholds increased. As shown in Table 2, the FDRs for the t and U statistics were evaluated to be close to the given significance levels, while the FDRs for the chi-squared and P-value statistics were lower than the given significance levels, which suggested that the quick approximation method often yielded more conservative thresholds for the chi-squared and P-value statistics. Additionally, the U and chi-squared statistics yielded large FDRs for small sample sizes.

Table 1

The approximate and accurate threshold values of –log10(p) simulated for different population sizes

nStatisticBDBHQAPermutationConfidence interval
0.010.050.010.050.010.050.010.050.010.05
50t7.0446.3126.9156.243(6.835, 7.316)(6.034, 6.539)
U6.9686.2459.2648.088(9.120, 10.001)(7.738, 8.597)
|${\chi}^2$|7.2796.5579.2648.088(9.120, 10.001)(7.738, 8.597)
p7.0006.3016.9976.2887.3166.5386.9156.243(6.835, 7.316)(6.034, 6.539)
100t6.9986.2716.9346.245(6.738, 7.004)(6.067, 6.561)
U6.9636.2397.9697.063(7.709, 8.063)(6.834, 7.475)
|${\chi}^2$|7.2746.5517.9697.063(7.709, 8.063)(6.834, 7.475)
p7.0006.3016.9986.2877.0036.5606.9346.245(6.738, 7.004)(6.067, 6.561)
200t6.9776.2526.8376.284(6.775, 7.204)(6.104, 6.487)
U6.9606.2367.3096.677(7.237, 7.733)(6.472, 6.907)
|${\chi}^2$|7.2716.5487.3096.677(7.237, 7.733)(6.472, 6.907)
p7.0006.3016.9986.2867.3296.6076.8376.284(6.775, 7.204)(6.104, 6.487)
500U7.2476.2457.5216.372(7.265, 7.710)(6.245, 6.607)
|${\chi}^2$|7.2696.5477.5216.372(7.265, 7.710)(6.245, 6.607)
p7.0006.3016.9956.2887.3296.4457.3116.224(7.070, 7.489)(6.102, 6.446)
1000U6.9586.3237.0466.468(6.874, 7.655)(6.319, 6.776)
|${\chi}^2$|7.2696.5467.0466.468(6.874, 7.655)(6.319, 6.776)
p7.0006.3016.9976.2817.3296.6076.9536.391(6.786, 7.544)(6.245, 6.691)
2000U6.9586.2347.0666.403(6.925, 7.274)(6.171, 6.637)
|${\chi}^2$|7.2686.5467.0666.403(6.925, 7.274)(6.171, 6.637)
p7.0006.3016.9976.2907.2316.4997.0046.175(6.913, 7.232)(6.042, 6.500)
nStatisticBDBHQAPermutationConfidence interval
0.010.050.010.050.010.050.010.050.010.05
50t7.0446.3126.9156.243(6.835, 7.316)(6.034, 6.539)
U6.9686.2459.2648.088(9.120, 10.001)(7.738, 8.597)
|${\chi}^2$|7.2796.5579.2648.088(9.120, 10.001)(7.738, 8.597)
p7.0006.3016.9976.2887.3166.5386.9156.243(6.835, 7.316)(6.034, 6.539)
100t6.9986.2716.9346.245(6.738, 7.004)(6.067, 6.561)
U6.9636.2397.9697.063(7.709, 8.063)(6.834, 7.475)
|${\chi}^2$|7.2746.5517.9697.063(7.709, 8.063)(6.834, 7.475)
p7.0006.3016.9986.2877.0036.5606.9346.245(6.738, 7.004)(6.067, 6.561)
200t6.9776.2526.8376.284(6.775, 7.204)(6.104, 6.487)
U6.9606.2367.3096.677(7.237, 7.733)(6.472, 6.907)
|${\chi}^2$|7.2716.5487.3096.677(7.237, 7.733)(6.472, 6.907)
p7.0006.3016.9986.2867.3296.6076.8376.284(6.775, 7.204)(6.104, 6.487)
500U7.2476.2457.5216.372(7.265, 7.710)(6.245, 6.607)
|${\chi}^2$|7.2696.5477.5216.372(7.265, 7.710)(6.245, 6.607)
p7.0006.3016.9956.2887.3296.4457.3116.224(7.070, 7.489)(6.102, 6.446)
1000U6.9586.3237.0466.468(6.874, 7.655)(6.319, 6.776)
|${\chi}^2$|7.2696.5467.0466.468(6.874, 7.655)(6.319, 6.776)
p7.0006.3016.9976.2817.3296.6076.9536.391(6.786, 7.544)(6.245, 6.691)
2000U6.9586.2347.0666.403(6.925, 7.274)(6.171, 6.637)
|${\chi}^2$|7.2686.5467.0666.403(6.925, 7.274)(6.171, 6.637)
p7.0006.3016.9976.2907.2316.4997.0046.175(6.913, 7.232)(6.042, 6.500)

n is population size; BD represents Bonferroni step-down adjustment, BH controlling FDR and QA quick approximation methods.

Table 1

The approximate and accurate threshold values of –log10(p) simulated for different population sizes

nStatisticBDBHQAPermutationConfidence interval
0.010.050.010.050.010.050.010.050.010.05
50t7.0446.3126.9156.243(6.835, 7.316)(6.034, 6.539)
U6.9686.2459.2648.088(9.120, 10.001)(7.738, 8.597)
|${\chi}^2$|7.2796.5579.2648.088(9.120, 10.001)(7.738, 8.597)
p7.0006.3016.9976.2887.3166.5386.9156.243(6.835, 7.316)(6.034, 6.539)
100t6.9986.2716.9346.245(6.738, 7.004)(6.067, 6.561)
U6.9636.2397.9697.063(7.709, 8.063)(6.834, 7.475)
|${\chi}^2$|7.2746.5517.9697.063(7.709, 8.063)(6.834, 7.475)
p7.0006.3016.9986.2877.0036.5606.9346.245(6.738, 7.004)(6.067, 6.561)
200t6.9776.2526.8376.284(6.775, 7.204)(6.104, 6.487)
U6.9606.2367.3096.677(7.237, 7.733)(6.472, 6.907)
|${\chi}^2$|7.2716.5487.3096.677(7.237, 7.733)(6.472, 6.907)
p7.0006.3016.9986.2867.3296.6076.8376.284(6.775, 7.204)(6.104, 6.487)
500U7.2476.2457.5216.372(7.265, 7.710)(6.245, 6.607)
|${\chi}^2$|7.2696.5477.5216.372(7.265, 7.710)(6.245, 6.607)
p7.0006.3016.9956.2887.3296.4457.3116.224(7.070, 7.489)(6.102, 6.446)
1000U6.9586.3237.0466.468(6.874, 7.655)(6.319, 6.776)
|${\chi}^2$|7.2696.5467.0466.468(6.874, 7.655)(6.319, 6.776)
p7.0006.3016.9976.2817.3296.6076.9536.391(6.786, 7.544)(6.245, 6.691)
2000U6.9586.2347.0666.403(6.925, 7.274)(6.171, 6.637)
|${\chi}^2$|7.2686.5467.0666.403(6.925, 7.274)(6.171, 6.637)
p7.0006.3016.9976.2907.2316.4997.0046.175(6.913, 7.232)(6.042, 6.500)
nStatisticBDBHQAPermutationConfidence interval
0.010.050.010.050.010.050.010.050.010.05
50t7.0446.3126.9156.243(6.835, 7.316)(6.034, 6.539)
U6.9686.2459.2648.088(9.120, 10.001)(7.738, 8.597)
|${\chi}^2$|7.2796.5579.2648.088(9.120, 10.001)(7.738, 8.597)
p7.0006.3016.9976.2887.3166.5386.9156.243(6.835, 7.316)(6.034, 6.539)
100t6.9986.2716.9346.245(6.738, 7.004)(6.067, 6.561)
U6.9636.2397.9697.063(7.709, 8.063)(6.834, 7.475)
|${\chi}^2$|7.2746.5517.9697.063(7.709, 8.063)(6.834, 7.475)
p7.0006.3016.9986.2877.0036.5606.9346.245(6.738, 7.004)(6.067, 6.561)
200t6.9776.2526.8376.284(6.775, 7.204)(6.104, 6.487)
U6.9606.2367.3096.677(7.237, 7.733)(6.472, 6.907)
|${\chi}^2$|7.2716.5487.3096.677(7.237, 7.733)(6.472, 6.907)
p7.0006.3016.9986.2867.3296.6076.8376.284(6.775, 7.204)(6.104, 6.487)
500U7.2476.2457.5216.372(7.265, 7.710)(6.245, 6.607)
|${\chi}^2$|7.2696.5477.5216.372(7.265, 7.710)(6.245, 6.607)
p7.0006.3016.9956.2887.3296.4457.3116.224(7.070, 7.489)(6.102, 6.446)
1000U6.9586.3237.0466.468(6.874, 7.655)(6.319, 6.776)
|${\chi}^2$|7.2696.5467.0466.468(6.874, 7.655)(6.319, 6.776)
p7.0006.3016.9976.2817.3296.6076.9536.391(6.786, 7.544)(6.245, 6.691)
2000U6.9586.2347.0666.403(6.925, 7.274)(6.171, 6.637)
|${\chi}^2$|7.2686.5467.0666.403(6.925, 7.274)(6.171, 6.637)
p7.0006.3016.9976.2907.2316.4997.0046.175(6.913, 7.232)(6.042, 6.500)

n is population size; BD represents Bonferroni step-down adjustment, BH controlling FDR and QA quick approximation methods.

Table 2

The simulated false discovery rates generated by different approximate thresholds

mnDistributionBDBHUt|${\chi}^2$|p
0.010.050.010.050.010.050.010.050.010.050.010.05
10000050N(0,6)0.0100.0400.0100.0440.2690.7980.0090.0370.1610.4950.0050.023
1000.0070.0450.0070.0470.0650.2500.0070.0490.0400.1380.0010.024
2000.0080.0480.0080.0490.0330.1340.0080.0500.0130.0680.0030.020
5000.0170.0420.0170.0440.0110.0600.0150.0320.0100.018
10000.0090.0670.0090.0690.0130.0590.0090.0420.0060.030
20000.0110.0560.0110.0590.0140.0590.0060.0320.0050.023
100001000.0080.0590.0080.0620.0460.1960.0010.0510.0270.1040.0050.031
20000.0150.0390.0150.0390.0190.0490.0130.0260.0100.019
500001000.0160.0510.0170.0540.0640.2070.0110.0510.0410.1080.0100.026
20000.0100.0550.0100.0610.0140.0520.0050.0350.0040.028
5000001000.0090.0480.0090.0530.0940.3540.0080.0500.0530.2040.0020.027
20000.0110.0350.0110.0370.0130.0500.0050.0200.0040.016
100000100U(1.5,10)0.0140.0500.0140.0540.0640.2720.0140.0520.0400.1520.0060.031
20000.0120.0700.0120.0730.0180.0760.0070.0420.0070.030
100|${\chi}^2$|(3)0.0930.2580.1000.3250.3300.3250.0930.2730.2220.5610.0600.164
20000.0100.0580.0100.0610.0120.0770.0070.0470.0060.039
mnDistributionBDBHUt|${\chi}^2$|p
0.010.050.010.050.010.050.010.050.010.050.010.05
10000050N(0,6)0.0100.0400.0100.0440.2690.7980.0090.0370.1610.4950.0050.023
1000.0070.0450.0070.0470.0650.2500.0070.0490.0400.1380.0010.024
2000.0080.0480.0080.0490.0330.1340.0080.0500.0130.0680.0030.020
5000.0170.0420.0170.0440.0110.0600.0150.0320.0100.018
10000.0090.0670.0090.0690.0130.0590.0090.0420.0060.030
20000.0110.0560.0110.0590.0140.0590.0060.0320.0050.023
100001000.0080.0590.0080.0620.0460.1960.0010.0510.0270.1040.0050.031
20000.0150.0390.0150.0390.0190.0490.0130.0260.0100.019
500001000.0160.0510.0170.0540.0640.2070.0110.0510.0410.1080.0100.026
20000.0100.0550.0100.0610.0140.0520.0050.0350.0040.028
5000001000.0090.0480.0090.0530.0940.3540.0080.0500.0530.2040.0020.027
20000.0110.0350.0110.0370.0130.0500.0050.0200.0040.016
100000100U(1.5,10)0.0140.0500.0140.0540.0640.2720.0140.0520.0400.1520.0060.031
20000.0120.0700.0120.0730.0180.0760.0070.0420.0070.030
100|${\chi}^2$|(3)0.0930.2580.1000.3250.3300.3250.0930.2730.2220.5610.0600.164
20000.0100.0580.0100.0610.0120.0770.0070.0470.0060.039

n is population size, m is the number of SNPs and BD represents Bonferroni step-down adjustment and BH controlling FDR methods.

Table 2

The simulated false discovery rates generated by different approximate thresholds

mnDistributionBDBHUt|${\chi}^2$|p
0.010.050.010.050.010.050.010.050.010.050.010.05
10000050N(0,6)0.0100.0400.0100.0440.2690.7980.0090.0370.1610.4950.0050.023
1000.0070.0450.0070.0470.0650.2500.0070.0490.0400.1380.0010.024
2000.0080.0480.0080.0490.0330.1340.0080.0500.0130.0680.0030.020
5000.0170.0420.0170.0440.0110.0600.0150.0320.0100.018
10000.0090.0670.0090.0690.0130.0590.0090.0420.0060.030
20000.0110.0560.0110.0590.0140.0590.0060.0320.0050.023
100001000.0080.0590.0080.0620.0460.1960.0010.0510.0270.1040.0050.031
20000.0150.0390.0150.0390.0190.0490.0130.0260.0100.019
500001000.0160.0510.0170.0540.0640.2070.0110.0510.0410.1080.0100.026
20000.0100.0550.0100.0610.0140.0520.0050.0350.0040.028
5000001000.0090.0480.0090.0530.0940.3540.0080.0500.0530.2040.0020.027
20000.0110.0350.0110.0370.0130.0500.0050.0200.0040.016
100000100U(1.5,10)0.0140.0500.0140.0540.0640.2720.0140.0520.0400.1520.0060.031
20000.0120.0700.0120.0730.0180.0760.0070.0420.0070.030
100|${\chi}^2$|(3)0.0930.2580.1000.3250.3300.3250.0930.2730.2220.5610.0600.164
20000.0100.0580.0100.0610.0120.0770.0070.0470.0060.039
mnDistributionBDBHUt|${\chi}^2$|p
0.010.050.010.050.010.050.010.050.010.050.010.05
10000050N(0,6)0.0100.0400.0100.0440.2690.7980.0090.0370.1610.4950.0050.023
1000.0070.0450.0070.0470.0650.2500.0070.0490.0400.1380.0010.024
2000.0080.0480.0080.0490.0330.1340.0080.0500.0130.0680.0030.020
5000.0170.0420.0170.0440.0110.0600.0150.0320.0100.018
10000.0090.0670.0090.0690.0130.0590.0090.0420.0060.030
20000.0110.0560.0110.0590.0140.0590.0060.0320.0050.023
100001000.0080.0590.0080.0620.0460.1960.0010.0510.0270.1040.0050.031
20000.0150.0390.0150.0390.0190.0490.0130.0260.0100.019
500001000.0160.0510.0170.0540.0640.2070.0110.0510.0410.1080.0100.026
20000.0100.0550.0100.0610.0140.0520.0050.0350.0040.028
5000001000.0090.0480.0090.0530.0940.3540.0080.0500.0530.2040.0020.027
20000.0110.0350.0110.0370.0130.0500.0050.0200.0040.016
100000100U(1.5,10)0.0140.0500.0140.0540.0640.2720.0140.0520.0400.1520.0060.031
20000.0120.0700.0120.0730.0180.0760.0070.0420.0070.030
100|${\chi}^2$|(3)0.0930.2580.1000.3250.3300.3250.0930.2730.2220.5610.0600.164
20000.0100.0580.0100.0610.0120.0770.0070.0470.0060.039

n is population size, m is the number of SNPs and BD represents Bonferroni step-down adjustment and BH controlling FDR methods.

Table S2 showed the approximate and accurate threshold estimates of –log10(p) that were obtained with the three competing methods and the permutation test for different numbers of SNPs (Table S3 of statistics in supplementary file). Among the three competing methods, the orders of the approximate threshold estimates did not vary with the simulated numbers of SNPs. For either the t statistics for the small population or the U statistics for the large population, the quick approximation method could generate empirical type I error rates close to the given significance levels. When using the uniform and chi-squared distributions to simulate the phenotypes, the three competing methods could robustly estimate the thresholds and control FDRs for the t statistics for the small population and the U and chi-squared statistics for the large population. For the small population, however, the permutation tests appeared to overestimate the accurate thresholds by the t statistics if the phenotype was generated from the more skewed distribution, such as chi-squared distribution.

Case analyses

We applied the quick approximation method to re-determine the critical thresholds for a GWAS for eight Arabidopsis thaliana (Arabidopsis) traits [25] (available online at http://archive.gramene.org/db/diversity/diversity_view) and four mouse traits [26] (available online at http://gscan.well.ox.ac.uk). In the two datasets, a total of 216 100 SNPs were genotyped for 199 Arabidopsis and 10 100 SNPs for 1940 mice. The Q–Q plots for phenotypes (not shown) showed reasonable non-normality of the X44_FRI, X59_FT.GH and X57_FT.Field traits in Arabidopsis. There were different sample sizes for the analyzed traits, because records were missing for some of the individuals. To eliminate confounding effects from the population structure, as shown in Figures S1 and S2 in the supplementary files, we applied the efficient mixed-model association eXpedited method [27] to the GWAS for these traits. For Arabidopsis traits with less than 200 records, Student’s t statistic was chosen to detect the association of the phenotype with the SNPs, while the U and chi-squared statistics were used for mouse traits from a large population. Phenotypes were shuffled 1000 times for the permutation tests.

Table 3 shows the approximate and accurate thresholds of –log10(p) for eight Arabidopsis traits and four mouse traits (Table S4 of statistics in supplementary file). All approximate thresholds of the t and U statistics for the Arabidopsis and mouse traits, respectively, fell within the confidence intervals of permutation tests, with the exception of the three non-normal Arabidopsis traits. As shown in the simulations, the permutation test indeed overestimated accurate thresholds for non-normal Arabidopsis traits, resulting in accurate threshold estimates that were far greater than those by the Bonferroni correction. For the four mouse traits, the approximate thresholds of chi-squared statistics were very close to the upper limits of confidence intervals, although they were not within the corresponding confidence intervals. For mouse traits, Benjamini–Hochberg correction underestimated the critical thresholds, as compared to the quick approximation and permutation test.

Table 3

The approximate and accurate threshold values of –log10(p) for eight Arabidopsis traits and four mouse traits

TraitsnStatisticBDBHQAPermutationConfidence interval
0.010.050.010.050.010.050.010.050.010.05
Ara-189t7.3356.6367.3356.6367.2566.5677.2136.346(7.046, 7.392)(6.192, 6.764)
Ara-2937.3356.6367.3356.6367.2636.5367.4246.544(7.133, 7.614)(6.304, 6.886)
Ara-3937.3356.6367.3356.6367.2566.5296.8796.347(6.712, 7.359)(6.133, 6.533)
Ara-41007.3356.6367.3356.6367.2596.4757.1616.437(6.903, 7.299)(6.251, 6.750)
Ara-51107.3356.6367.3356.6367.2626.5367.3396.670(7.188, 7.938)(6.483, 6.939)
Ara-61647.3356.6366.7335.6817.2486.5237.5476.605(7.462, 8.125)(6.471, 7.100)
Ara-71667.3356.6367.3355.0457.2466.5227.5856.894(7.429, 7.813)(6.681, 7.204)
Ara-81807.3356.6365.9545.0237.2596.5358.0537.075(7.868, 8.225)(6.736, 7.691)
Mice-11405U6.0405.3414.3783.5795.6704.9405.5804.863(5.485, 5.705)(4.647, 5.184)
|${\chi}^2$|5.9835.2555.5804.863(5.485, 5.705)(4.647, 5.184)
Mice-21571U6.0405.3414.9993.9105.6844.9545.4864.873(5.373, 5.828)(4.662, 5.151)
|${\chi}^2$|5.9975.2695.4864.873(5.373, 5.828)(4.662, 5.151)
Mice-31642U6.0415.3424.9624.2285.6754.9455.5094.902(5.375, 5.896)(4.676, 5.189)
|${\chi}^2$|5.9885.2605.5094.902(5.375, 5.896)(4.676, 5.189)
Mice-41643U6.0415.3425.0414.1125.6694.9395.5234.803(5.353, 5.918)(4.622, 5.048)
|${\chi}^2$|5.9825.2545.5234.803(5.353, 5.918)(4.622, 5.048)
TraitsnStatisticBDBHQAPermutationConfidence interval
0.010.050.010.050.010.050.010.050.010.05
Ara-189t7.3356.6367.3356.6367.2566.5677.2136.346(7.046, 7.392)(6.192, 6.764)
Ara-2937.3356.6367.3356.6367.2636.5367.4246.544(7.133, 7.614)(6.304, 6.886)
Ara-3937.3356.6367.3356.6367.2566.5296.8796.347(6.712, 7.359)(6.133, 6.533)
Ara-41007.3356.6367.3356.6367.2596.4757.1616.437(6.903, 7.299)(6.251, 6.750)
Ara-51107.3356.6367.3356.6367.2626.5367.3396.670(7.188, 7.938)(6.483, 6.939)
Ara-61647.3356.6366.7335.6817.2486.5237.5476.605(7.462, 8.125)(6.471, 7.100)
Ara-71667.3356.6367.3355.0457.2466.5227.5856.894(7.429, 7.813)(6.681, 7.204)
Ara-81807.3356.6365.9545.0237.2596.5358.0537.075(7.868, 8.225)(6.736, 7.691)
Mice-11405U6.0405.3414.3783.5795.6704.9405.5804.863(5.485, 5.705)(4.647, 5.184)
|${\chi}^2$|5.9835.2555.5804.863(5.485, 5.705)(4.647, 5.184)
Mice-21571U6.0405.3414.9993.9105.6844.9545.4864.873(5.373, 5.828)(4.662, 5.151)
|${\chi}^2$|5.9975.2695.4864.873(5.373, 5.828)(4.662, 5.151)
Mice-31642U6.0415.3424.9624.2285.6754.9455.5094.902(5.375, 5.896)(4.676, 5.189)
|${\chi}^2$|5.9885.2605.5094.902(5.375, 5.896)(4.676, 5.189)
Mice-41643U6.0415.3425.0414.1125.6694.9395.5234.803(5.353, 5.918)(4.622, 5.048)
|${\chi}^2$|5.9825.2545.5234.803(5.353, 5.918)(4.622, 5.048)

n is population size; BD represents Bonferroni step-down adjustment, BH controlling FDR and QA quick approximation methods. Ara-1–8 represent the trait X182_Hypocotyl.length, X278_Germ.in.dark, X29_Se82, X272_Seedling.Growth, X283_Storage.56.days, X44_FRI, X59_FT.GH, X57_FT.Field, respectively, in Arabidopsis. Mice-1–4 refer to the trait Imm.PctCD8, Haem.MCH, FPS.Pre.Bang.ToneMean, FPS.Pre.Bang.Mean, respectively, in mouse.

Table 3

The approximate and accurate threshold values of –log10(p) for eight Arabidopsis traits and four mouse traits

TraitsnStatisticBDBHQAPermutationConfidence interval
0.010.050.010.050.010.050.010.050.010.05
Ara-189t7.3356.6367.3356.6367.2566.5677.2136.346(7.046, 7.392)(6.192, 6.764)
Ara-2937.3356.6367.3356.6367.2636.5367.4246.544(7.133, 7.614)(6.304, 6.886)
Ara-3937.3356.6367.3356.6367.2566.5296.8796.347(6.712, 7.359)(6.133, 6.533)
Ara-41007.3356.6367.3356.6367.2596.4757.1616.437(6.903, 7.299)(6.251, 6.750)
Ara-51107.3356.6367.3356.6367.2626.5367.3396.670(7.188, 7.938)(6.483, 6.939)
Ara-61647.3356.6366.7335.6817.2486.5237.5476.605(7.462, 8.125)(6.471, 7.100)
Ara-71667.3356.6367.3355.0457.2466.5227.5856.894(7.429, 7.813)(6.681, 7.204)
Ara-81807.3356.6365.9545.0237.2596.5358.0537.075(7.868, 8.225)(6.736, 7.691)
Mice-11405U6.0405.3414.3783.5795.6704.9405.5804.863(5.485, 5.705)(4.647, 5.184)
|${\chi}^2$|5.9835.2555.5804.863(5.485, 5.705)(4.647, 5.184)
Mice-21571U6.0405.3414.9993.9105.6844.9545.4864.873(5.373, 5.828)(4.662, 5.151)
|${\chi}^2$|5.9975.2695.4864.873(5.373, 5.828)(4.662, 5.151)
Mice-31642U6.0415.3424.9624.2285.6754.9455.5094.902(5.375, 5.896)(4.676, 5.189)
|${\chi}^2$|5.9885.2605.5094.902(5.375, 5.896)(4.676, 5.189)
Mice-41643U6.0415.3425.0414.1125.6694.9395.5234.803(5.353, 5.918)(4.622, 5.048)
|${\chi}^2$|5.9825.2545.5234.803(5.353, 5.918)(4.622, 5.048)
TraitsnStatisticBDBHQAPermutationConfidence interval
0.010.050.010.050.010.050.010.050.010.05
Ara-189t7.3356.6367.3356.6367.2566.5677.2136.346(7.046, 7.392)(6.192, 6.764)
Ara-2937.3356.6367.3356.6367.2636.5367.4246.544(7.133, 7.614)(6.304, 6.886)
Ara-3937.3356.6367.3356.6367.2566.5296.8796.347(6.712, 7.359)(6.133, 6.533)
Ara-41007.3356.6367.3356.6367.2596.4757.1616.437(6.903, 7.299)(6.251, 6.750)
Ara-51107.3356.6367.3356.6367.2626.5367.3396.670(7.188, 7.938)(6.483, 6.939)
Ara-61647.3356.6366.7335.6817.2486.5237.5476.605(7.462, 8.125)(6.471, 7.100)
Ara-71667.3356.6367.3355.0457.2466.5227.5856.894(7.429, 7.813)(6.681, 7.204)
Ara-81807.3356.6365.9545.0237.2596.5358.0537.075(7.868, 8.225)(6.736, 7.691)
Mice-11405U6.0405.3414.3783.5795.6704.9405.5804.863(5.485, 5.705)(4.647, 5.184)
|${\chi}^2$|5.9835.2555.5804.863(5.485, 5.705)(4.647, 5.184)
Mice-21571U6.0405.3414.9993.9105.6844.9545.4864.873(5.373, 5.828)(4.662, 5.151)
|${\chi}^2$|5.9975.2695.4864.873(5.373, 5.828)(4.662, 5.151)
Mice-31642U6.0415.3424.9624.2285.6754.9455.5094.902(5.375, 5.896)(4.676, 5.189)
|${\chi}^2$|5.9885.2605.5094.902(5.375, 5.896)(4.676, 5.189)
Mice-41643U6.0415.3425.0414.1125.6694.9395.5234.803(5.353, 5.918)(4.622, 5.048)
|${\chi}^2$|5.9825.2545.5234.803(5.353, 5.918)(4.622, 5.048)

n is population size; BD represents Bonferroni step-down adjustment, BH controlling FDR and QA quick approximation methods. Ara-1–8 represent the trait X182_Hypocotyl.length, X278_Germ.in.dark, X29_Se82, X272_Seedling.Growth, X283_Storage.56.days, X44_FRI, X59_FT.GH, X57_FT.Field, respectively, in Arabidopsis. Mice-1–4 refer to the trait Imm.PctCD8, Haem.MCH, FPS.Pre.Bang.ToneMean, FPS.Pre.Bang.Mean, respectively, in mouse.

The critical thresholds by Bonferroni correction were 7.335 and 6.636 at the significance levels of 1% and 5% for Arabidopsis traits and 6.041 and 5.342 for mouse traits, which were almost the same by both Bonferroni step-down adjustment and Benjamini–Hochberg correction. In Figures 2 and S3, we depicted the Manhattan plots for the eight Arabidopsis traits and four mouse traits with horizontal reference lines of the critical thresholds at the significance level of 5% obtained by quick approximation, permutation test and Bonferroni correction. For the traits with the detectable QTNs, such as the four mouse traits and three non-normal Arabidopsis traits, the critical thresholds estimated by quick approximation resided between those by permutation test and Bonferroni correction. Therefore, the number of the QTNs detected by the approximate thresholds was not greater than the accurate thresholds but not less than Bonferroni correction’s thresholds (data not shown).

Manhattan plots for the four mouse traits. The red, blue and green horizontal reference lines represent the critical thresholds at the significance level of 5% obtained by quick approximation, permutation test and Bonferroni correction, respectively.
Figure 2

Manhattan plots for the four mouse traits. The red, blue and green horizontal reference lines represent the critical thresholds at the significance level of 5% obtained by quick approximation, permutation test and Bonferroni correction, respectively.

Discussion

Hypothesis testing when a nuisance parameter is present only under the alternative, based on the work of Davies (1977, 1987), has been successfully applied to the quick approximation of critical thresholds for linkage analyses [17, 28, 29]. However, the approximation was evaluated using U and chi-squared statistical values, obtained from a large sample population, without considering the effects of the approximation on the small sample sizes that are often used in a linkage analysis. In fact, a small sample size is often encountered in practice for both linkage analysis and GWASs, such that Student’s t and F statistics were introduced to statistically infer the association of the genetic markers with the traits of interest. Fortunately, for a linear model with unknown residual variances, Davies [30] extended the quick approximation of critical thresholds for the U and chi-squared statistics to the t and F statistics. In this study, we adapted Davies’s results [30–32] for the quick approximation of empirical thresholds in order to apply them to the small and large sample sizes for GWASs. The quick approximation of critical thresholds was developed, according to Fisher’s argument of distributions for P-values, for situations when only the statistical probability P-values for the SNPs are available, regardless of the test statistics. This made the quick approximation of critical thresholds universally applicable for GWASs.

The Bonferroni adjustment was computationally the simplest among the most widely used multiple testing approaches, although it was too conservative and its workload was not associated with a GWAS computation. In contrast, the permutation test, quick approximation, Bonferroni step-down adjustment and Benjamini–Hochberg correction were evaluated by statistical values that were obtained from a GWAS. Given statistical values, the quick approximation took little to no computational time, similar to the Bonferroni step-down adjustment and Benjamini–Hochberg correction, such that their workloads depended almost completely on the GWAS computation. However, the permutation test required a large number of GWAS computations to attain accurate thresholds, and its workload increased drastically as the type I error rate was reduced. The method proposed here for computing approximate thresholds is fast and easy to implement into existing packages for GWASs with minimal effort. The simulations showed that the approximate thresholds fell within the confidence intervals of the accurate thresholds that were calculated by the permutation tests. For the t or U statistics, the quick approximation method performed slightly conservative, as compared to the Bonferroni adjustment, Bonferroni step-down adjustment and Benjamini–Hochberg correction. Additionally, the quick approximation was relatively robust for non-normality but should be used with caution if there is a remarkable departure from normality, especially for small populations. The case analysis demonstrated that the quick method yields thresholds similar to those obtained by the permutation test.

Key Points

  • Standard normal statistics and Student’s t or F statistics, in addition to chi-squared statistics, were used to map QTNs for small and large sample sizes in GWASs.

  • Hypothesis testing when a nuisance parameter is present only under the alternative was introduced to quickly approximate the critical thresholds for GWASs.

  • When only the P-values were available, the approximate critical thresholds were estimated with chi-squared statistics, formulated by P-values.

  • High similarities in the critical thresholds between the accurate and approximate estimations were highlighted by extensive simulations and real data analysis.

Funding

Special Scientific Research Funds for Central Non-profit Institutes, Chinese Academy of Fishery Sciences (2017A001).

Zhiyu Hao is currently a Master’s student in the College of Animal Science and Technology at the Northeast Agricultural University.

Li Jiang is an associate professor in the Research Centre for Aquatic Biotechnology at the Chinese Academy of Fishery Sciences. She is interested in developing and applying statistical methodologies for genome-wide association studies.

Jin Gao is currently a PhD student in the Research Centre for Aquatic Biotechnology at the Chinese Academy of Fishery Sciences.

Jinhua Ye is a lecturer in the Department of Mathematics at the Heilongjiang Bayi Agricultural University. Her research interest is in mapping quantitative trait loci by genome-wide association studies.

Jingli Zhao is currently a Master’s student in the Research Centre for Aquatic Biotechnology at the Chinese Academy of Fishery Sciences.

Shuling Li is a professor in the College of Life Science at the Northeast Agricultural University. Her research focuses on animal behavior genetics and genomics.

Runqing Yang is a professor in the Research Centre for Aquatic Biotechnology at the Chinese Academy of Fishery Sciences. He is interested in developing statistical methodologies for genome-wide association studies.

References

1.

Sham
PC
,
Purcell
SM
.
Statistical power and significance testing in large-scale genetic studies
.
Nat Rev Genet
2014
;
15
:
335
46
.

2.

Hochberg
Y
,
Tamhane
AC
.
Multiple Comparison Procedures.
New York
:
Wiley
,
1987
.

3.

Young
SS
,
Young
SS
,
Young
SS
.
Resampling-Based Multiple Testing: Examples and Methods for P-Value Adjustment.
John Wiley & Sons
,
1993
.

4.

Holland
BS
,
Copenhaver
DP
.
An improved sequentially rejective Bonferroni test procedure
.
Biometrics
1987
;
43
:
417
23
.

5.

Benjamini
Y
,
Hochberg
Y
.
Controlling the False Discovery Rate—a Practical and Powerful Approach to Multiple Testing
,
1995
.

6.

Duggal
P
,
Gillanders
EM
,
Holmes
TN
, et al.
Establishing an adjusted p-value threshold to control the family-wide type 1 error in genome wide association studies
.
BMC Genomics
2008
;
9
:
516
.

7.

Cheverud
JM
.
A simple correction for multiple comparisons in interval mapping genome scans
.
Heredity
2001
;
87
:
52
8
.

8.

Li
J
,
Ji
L
.
Adjusting multiple testing in multilocus analyses using the eigenvalues of a correlation matrix
.
Heredity
2005
;
95
:
221
7
.

9.

Nyholt
DR
.
A simple correction for multiple testing for single-nucleotide polymorphisms in linkage disequilibrium with each other
.
Am J Hum Genet
2004
;
74
:
765
9
.

10.

Moskvina
V
,
Schmidt
K
.
On multiple-testing correction in genome-wide association studies
.
Genet Epidemiol
2008
;
32
:
567
73
.

11.

Galwey
N
.
A new measure of the effective number of tests, a practical tool for comparing families of non-independent significance tests
.
Genet Epidemiol
2009
;
33
:
559
68
.

12.

Han
B
,
Kang
HM
,
Eskin
E
.
Rapid and accurate multiple testing correction and power estimation for millions of correlated markers
.
PLoS Genet
2009
;
5
:
e1000456
.

13.

Salyakina
D
,
Seaman
SR
,
Browning
BL
, et al.
Evaluation of Nyholt's procedure for multiple testing correction
.
Hum Hered
2005
;
60
:
19
25
.

14.

Li
MX
,
Yeung
JMY
,
Cherny
SS
, et al.
Evaluating the effective numbers of independent tests and significant P-value thresholds in commercial genotyping arrays and public imputation reference datasets
.
Hum Genet
2012
;
131
:
747
56
.

15.

Pahl
R
,
Schäfer
H
.
PERMORY: an LD-exploiting permutation test algorithm for powerful genome-wide association testing
.
Bioinformatics
2010
;
26
:
2093
100
.

16.

Metzker
ML
.
Sequencing technologies—the next generation
.
Nat Rev Genet
2010
;
11
:
31
46
.

17.

Piepho
HP
.
A quick method for computing approximate thresholds for quantitative trait loci detection
.
Genetics
2001
;
157
:
425
.

18.

Davies
RB
.
Hypothesis testing when a nuisance parameter is present only under the alternative
.
Biometrika
1977
;
64
:
247
54
.

19.

Davies
RB
.
Hypothesis testing when a nuisance parameter is present only under the alternative
.
Biometrika
1987
;
74
:
33
43
.

20.

Davies
RB
.
Hypothesis testing when a nuisance parameter is present only under the alternative: linear model case
.
Biometrika
2002
;
89
:
484
9
.

21.

Fisher
RA
.
Statistical Method for Research Workers
.
Edinburgh
:
Oliver and Boyd
,
1950
.

22.

Wright
S
.
The genetical structure of populations
.
Ann Eugen
1951
;
15
:
323
54
.

23.

Balding
DJ
,
Nichols
RA
.
A method for quantifying differentiation between populations at multi-allelic loci and its implications for investigating identity and paternity
.
Genetica
1995
;
96
:
3
.

24.

Mood
AM
,
Graybill
FA
,
Boes
DC
.
Introduction to the Theory of Statistics.
New York
:
McGraw-Hill
,
1974
.

25.

Atwell
S
,
Huang
YS
,
Vilhjálmsson
BJ
, et al.
Genome-wide association study of 107 phenotypes in Arabidopsis thaliana inbred lines
.
Nature
2010
;
465
:
627
31
.

26.

Valdar
W
,
Solberg
LC
,
Gauguier
D
, et al.
Genome-wide genetic association of complex traits in heterogeneous stock mice
.
Nat Genet
2006
;
38
:
879
87
.

27.

Kang
HM
,
Sul
JH
,
Service SK
, et al.
Variance component model to account for sample structure in genome-wide association studies
.
Nat Genet
2010
;
42
:
348
54
.

28.

Rebaï
A
,
Goffinet
B
,
Mangin
B
.
Approximate thresholds of interval mapping tests for QTL detection
.
Genetics
1994
;
138
:
235
.

29.

Doerge
RW
,
Rebaï
A
.
Significance thresholds for QTL interval mapping tests
.
Heredity
1996
;
76
:
459
64
.

30.

Davies
RB
.
Hypothesis testing when a nuisance parameter is present only under the alternative: linear model case
.
Biometrika
2001
;
89
:
484
9
.

31.

Davies
RB
.
Hypothesis testing when a nuisance parameter is present only under the alternative
.
Biometrika
1977
;
64
:
247
54
.

32.

Davies
RB
.
Hypothesis testing when a nuisance parameter is present only under the alternative
.
Biometrika
1987
;
74
:
33
43
.

This article is published and distributed under the terms of the Oxford University Press, Standard Journals Publication Model (https://dbpia.nl.go.kr/journals/pages/open_access/funder_policies/chorus/standard_publication_model)

Supplementary data