Skip to main content

Evaluation of a LASSO regression approach on the unrelated samples of Genetic Analysis Workshop 17

Abstract

The Genetic Analysis Workshop 17 data we used comprise 697 unrelated individuals genotyped at 24,487 single-nucleotide polymorphisms (SNPs) from a mini-exome scan, using real sequence data for 3,205 genes annotated by the 1000 Genomes Project and simulated phenotypes. We studied 200 sets of simulated phenotypes of trait Q2. An important feature of this data set is that most SNPs are rare, with 87% of the SNPs having a minor allele frequency less than 0.05. For rare SNP detection, in this study we performed a least absolute shrinkage and selection operator (LASSO) regression and F tests at the gene level and calculated the generalized degrees of freedom to avoid any selection bias. For comparison, we also carried out linear regression and the collapsing method, which sums the rare SNPs, modified for a quantitative trait and with two different allele frequency thresholds. The aim of this paper is to evaluate these four approaches in this mini-exome data and compare their performance in terms of power and false positive rates. In most situations the LASSO approach is more powerful than linear regression and collapsing methods. We also note the difficulty in determining the optimal threshold for the collapsing method and the significant role that linkage disequilibrium plays in detecting rare causal SNPs. If a rare causal SNP is in strong linkage disequilibrium with a common marker in the same gene, power will be much improved.

Background

With the rapid development of technologies, more and more single-nucleotide polymorphisms (SNPs) have become available and, in particular, most of the rare variants can be identified using the next-generation sequencing technique. However, detecting associated rare variants that contribute to phenotypic variation is still a huge challenge. Current approaches for testing rare variants include grouping the rare variants based on a threshold of the minor allele frequency (MAF) [1], summing the rare variants weighted by the allele frequencies in control subjects [2, 3], and clustering rare haplotypes using family data [4]. Another approach is to use a penalized regression, which can avoid the singular design matrix that may result from rare variants by adding a penalty, such as the least absolute shrinkage and selection operator (LASSO) and ridge penalties [5, 6]. In this analysis, we evaluated the LASSO regression, linear regression and the collapsing methods by comparing their power and false positive rates. Based on the results, we recommend the LASSO approach to detect rare SNPs.

Methods

Data checking

In the Genetic Analysis Workshop 17 (GAW17) simulated data set, there are no missing genotype data. Among all the 24,487 SNPs, 91% have a MAF less than 0.1, 87% have a MAF less than 0.05, and 75% have a MAF less than 0.01. Moreover, 39% of the SNPs have a MAF less than 0.001, which leads to 9,433 SNPs being singletons among 697 unrelated individuals. Owing to the rareness of the variants, we do not examine Hardy-Weinberg disequilibrium as a quality control procedure in this study. Thus we include all SNPs and all individuals for the association analysis.

LASSO regression

To deal with the singular matrix in linear regression caused by the rare variants, we adopt a statistical method that effectively shrinks the coefficients of unassociated SNPs and reduces the variance of the estimated regression coefficients. Here, we apply the LASSO penalty [7] to implement this regression analysis.

At the ith SNP site, we code the genotype as 0, 1, or 2 to represent 0, 1, or 2 copies of the minor allele, which is the ith column in the design matrix represented by X. For the quantitative trait y, the regression can be written:

(1)

where β is the vector of regression coefficients. In a LASSO regression, the elements of β are the estimates that minimize the loss:

(2)

where n is the number of individuals, L is the number of SNP sites, and λ is the tuning parameter. The LASSO regression was implemented in the R package glmnet.

Gene-level association tests

The association is tested on the gene level. Within a gene, the dependent variable is Q2 of the GAW17 data set, and the independent variables are the genotypes of all the SNPs in the gene. We use a model, with a LASSO penalty, in which no interactions are involved. This model is indexed as M1. To test for the association between a gene and Q2, we use F statistics to test for the significance between models M1 and M0, where M0 is taken to be the model under the null hypothesis that β is a vector of zeros. Let RSSM1 and RSSM0 be the residual sums of squares of models M1 and M0, respectively. To correct for selection bias, we use the generalized degrees of freedom (GDF) [8], indicated by GDF(M), in the F tests for model M1; the GDF is larger than the number of nonzero coefficients. The F statistic is constructed as follows:

(3)

which asymptotically follows the F distribution with (GDF(M) – 1, n – GDF(M)) degrees of freedom. The P-values for each gene are obtained from the F distribution given in Eq. (3).

GDF and λ

In classical linear models, the number of covariates is fixed; therefore the number of degrees of freedom is equal to the number of covariates. However, the situation is different in a LASSO regression: The number of nonzero coefficients can no longer accurately measure the model complexity. For a LASSO regression, which involves variable selection, the GDF was introduced [8] to correct for selection bias and to accurately measure the degrees of freedom of the obtained model. The GDF of a model is defined as the average sensitivity of the fitted values to a small change in the observed values. The parametric bootstrapping method is used to estimate the GDF [8, 9].

Suppose that the observed value y i , i = 1, …, n, is modeled as μ i + ε, where μ i is the expectation of y i and ε is Gaussian white noise with variance σ2. An estimate s2 for σ2 can be obtained by an ordinary regression. Given a modeling procedure M: y → μ, GDF(M), the GDF of the modeling procedure M, can be estimated as follows: (1) For t = 1, …, T, where T = 100 here, first generate ε ti ~ normal(0, s2), i = 1, …, n. Then, evaluate on the basis of the modeling procedure. (2) Calculate as the regression slope from:

(4)

(3) Finally, calculate:

(5)

Given GDF(M), the extended Akaike’s A Information Criterion (AIC) is defined as:

(6)

Thus the tuning parameter λ is selected to be the one that minimizes the extended AIC value.

Alternative methods: Flinearand combined multivariate and the collapsing method for quantitative traits

As a comparison, we also carry out the F test based on general linear regression for each gene, which we call Flinear. A second alternative method is the combined multivariate and collapsing (CMC) method [1], which is a unified approach that combines collapsing and multivariate tests for a binary trait. We modify the CMC method for the quantitative trait, in which markers are divided into rare and common subgroups, on the basis of a predefined allele frequency threshold (δ); within the rare subgroup an individual is coded 1 if a rare allele is present at any of the variant sites and 0 otherwise. After this collapsing, we calculate the F test to test for the association. We call this approach QCMC(δ) for convenience, and we consider δ = 0.01 and 0.05 in this paper.

Results

We evaluated the power and false-positive rates of the FLASSO, Flinear, QCMC(0.01), and QCMC(0.05) tests based on the 200 replicates of the GAW17 data set. The significance level of the tests was first set to 1.6 × 10–5, which is the Bonferroni-corrected significance level of 0.05 adjusted by the number of genes, that is, 0.05/3,205. However, because of the small sample sizes in the GAW17 data set, the power of the association tests was poor and could not be compared in our four tests. Therefore we also used the weak significance level of 0.01 for method comparison.

We examined the answers to the GAW17 simulation after our association analyses were completed. In the answers, Q2 is influenced by 72 SNPs in 13 genes, where the MAFs and effect sizes (β i , the elements of β) could be found for each causal SNP. Thus the variance contributed by each SNP to the phenotype could be calculated as under the assumption of an additive model, where q is the MAF. Therefore we calculated the variance contribution for a gene using:

(7)

As shown in Table 1, both genes VNN3 and VNN1 have a variance contribution of approximately 0.02; SREBF1, BCHE, VLDLR, SIRT1, PDGFD, LPL, and PLAT have variance contributions of approximately 0.01 individually; and RARB, GCKR, VWF, and INSIG1 have variance contributions between 0.0002 and 0.005. The power is dependent on the variance attributed to the gene.

Table 1 True variance contributions of 13 causal genes given in the GAW17 answers

We evaluated the power of the four methods based on the 13 causal genes using the 200 replicates (Figure 1). In general, the LASSO regression outperformed linear regression for all causal genes and gained more than 10% power on the first four genes, as shown in Figure 1. The QCMC(0.01) method performed better than the QCMC(0.05) method because 91.7% of the MAFs of causal SNPs were less frequent than 0.01. Except for the VNN1 and SREBF1 genes, the LASSO method was more powerful than the two QCMC methods. This is quite easy to understand. The VNN1 gene has two causal SNPs, which have MAFs of 0.006 and 0.17, and all the causal SNP variants are less frequent than 0.005 in the SREBF1 gene. For this reason, both the QCMC(0.01) and the QCMC(0.05) tests are able to collapse the causal SNPs perfectly and thereby lead to a higher power than the LASSO approach for these two genes.

Figure 1
figure 1

Power to detect 13 causal genes at the significance levels of 0.01 and 1.6 × 10–5 in 200 replicates. The x-axis indicates the 13 genes sorted in decreasing order of the power of the FLASSO test, and the y-axis indicates the corresponding power. The power is shown as solid black lines for the significance level 0.01 and as red dashed lines for the significance 1.6 × 10–5.

In general, all the tests increased the power when a gene’s contribution to the phenotype variation increased. However, we observed some exceptions, possibly because the power depends on many other factors, such as allele frequency and linkage disequilibrium among the SNPs within a gene. First, although their contributions to the phenotype variation were similar, we had more power to detect VNN1, which consists of two causal SNPs, with one of them being common (MAF = 0.17), than VNN3, which consists of seven rare causal SNPs. Second, for the GCKR gene, which has only one causal SNP, we also had reasonable power, in contrast to its small contribution to the phenotype variation. The association for these two genes was concentrated in a small number of causal SNPs and hence was easier to detect. Third, the SIRT1 and VLDLR genes had a similar number of SNPs, number of causal SNPs, MAFs, and variance contribution; however, SIRT1 gained much more power than VLDLR did. To understand why, we examined the linkage disequilibrium among each of these genes (using Haploview, http://www.broad.mit.edu/mpg/haploview) (Figure 2). SIRT1 includes a common SNP, C10S3059 (MAF = 0.167), that is in linkage disequilibrium with the causal rare SNP, C10S3048 (MAF = 0.002). The four gametes formed by these two SNPs are CT (83.7%), CC (16.6%), GC (0.1%), and GT (0.1%); and the D′ value is 0.5 (R2 = 0.003). Among the 55 significant tests of the SIRT1 gene in 200 replicates, 81.8%, 60%, and 50.9% of the LASSO models selected SNP C10S3059, C10S3048, or both, respectively, in their M1 models. However, for VLDLR, although SNP C9S341 (MAF = 0.095) was also in linkage disequilibrium with the causal SNP C9S444, which has MAF = 0.001 (D′ = 0.384 and R2 = 0.002), it was not as common as C10S3059 and the linkage disequilibrium pattern was not the same as that for SIRT1.

Figure 2
figure 2

Linkage disequilibrium plot for genes SIRT1 and VLDLR. Linkage disequilibrium plots generated from Haploview. The values of R2 are shown in each cell. The color code in the Haploview plot follows the standard color scheme for Haploview: white, |D′| < 1, LOD < 2; shades of pink/red, |D′| < 1, LOD ≥ 2; blue, | D′| = 1, LOD < 2; red, |D′| = 1, LOD ≥ 2.

We also investigated the false-positive rates by counting the frequency of the P-values that were not larger than a specific significance level for all of the 3,192 noncausal genes over the 200 replicates (Table 2). For some unknown reason, all four methods had inflated false-positive rates, and the inflation of the FLASSO test was slightly bigger than that of the other three tests, but not significantly so.

Table 2 False-positive rates at the significance levels of 0.01 and 1.6 × 10–5 (the Bonferroni-corrected significance level of 0.05)

Discussion and conclusions

In this study, we used the LASSO regression and calculated the GDF for the F tests to avoid selection bias. This method requires using a parametric bootstrap to obtain the GDF; therefore it is computationally not as fast as the linear regression and collapsing methods. In general, the FLASSO test is more powerful than the other methods.

Linear regression is the least powerful approach because of the large number of rare SNPs and because no deduction is made in the large number of degrees of freedom. The collapsing test requires specifying the predefined allele frequency threshold for grouping rare SNPs. It is difficult to determine this criterion optimally when in reality the true disease model is never known. For an extreme example, the QCMC(0.001) test was identical to the linear regression approach and the QCMC(0.1) test had no power at all in these data. Therefore, from this point of view, we recommend the LASSO approach for detecting rare SNPs.

Based on the power comparison of the SIRT1 and VLDLR genes, we observed some evidence that linkage disequilibrium played a significant role in detecting rare causal SNPs. If a rare causal SNP is in strong linkage disequilibrium with a common marker in the same gene, it will perform much better in terms of power. It would be of interest to further investigate the role of linkage disequilibrium between common noncausal markers and rare causal SNPs on the power to detect rare causal SNPs and hence determine a more powerful test.

References

  1. Li B, Leal SM: Methods for detecting associations with rare variants for common diseases: application to analysis of sequence data. Am J Hum Genet. 2008, 83: 311-321. 10.1016/j.ajhg.2008.06.024.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  2. Madsen BE, Browning SR: A groupwise association test for rare mutations using a weighted sum statistic. PLoS Genet. 2009, 5: e1000384-10.1371/journal.pgen.1000384.

    Article  PubMed Central  PubMed  Google Scholar 

  3. Price AL, Kryukov GV, de Bakker PI, Purcell SM, Staples J, Wei LJ, Sunyaev SR: Pooled association tests for rare variants in exon-resequencing studies. Am J Hum Genet. 2010, 86: 832-838. 10.1016/j.ajhg.2010.04.005.

    Article  PubMed Central  PubMed  Google Scholar 

  4. Zhu X, Feng T, Li Y, Lu Q, Elston RC: Detecting rare variants for complex traits using family and unrelated data. Genet Epidemiol. 2010, 34: 171-187. 10.1002/gepi.20449.

    Article  PubMed Central  PubMed  Google Scholar 

  5. Guo W, Lin S: Generalized linear modeling with regularization for detecting common disease rare haplotype association. Genet Epidemiol. 2009, 33: 308-316. 10.1002/gepi.20382.

    Article  PubMed Central  PubMed  Google Scholar 

  6. Zhou H, Sehl ME, Sinsheimer JS, Lange K: Association screening of common and rare genetic variants by penalized regression. Bioinformatics. 2010, 26: 2375-2382. 10.1093/bioinformatics/btq448.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  7. Tibshirani R: Regression shrinkage and selection via the LASSO. J R Stat Soc B. 1996, 58: 267-288.

    Google Scholar 

  8. Ye J: On measuring and correcting the effects of data mining and model selection. J Am Stat Assoc. 1998, 93: 120-131. 10.2307/2669609.

    Article  Google Scholar 

  9. Li Y, Sung WK, Liu JJ: Association mapping via regularized regression analysis of single-nucleotide-polymorphism haplotypes in variable-sized sliding windows. Am J Hum Genet. 2007, 80: 705-715. 10.1086/513205.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

Download references

Acknowledgments

This work was supported by National Institutes of Health (NIH) grants HL074166, HL086718 from the National Heart, Lung, and Blood Institute, HG003054 from the National Human Genome Research Institute, RR03655 from the National Center for Research Resources, and P30 CAD43703 from the National Cancer Institute. The Genetic Analysis Workshops are supported by NIH grant R01 GM031575 from the National Institute of General Medical Sciences. This work was also partially supported by National Natural Science Foundation of China grant 10901031.

This article has been published as part of BMC Proceedings Volume 5 Supplement 9, 2011: Genetic Analysis Workshop 17. The full contents of the supplement are available online at http://www.biomedcentral.com/1753-6561/5?issue=S9.

Author information

Authors and Affiliations

Authors

Corresponding authors

Correspondence to Wei Guo or Xiaofeng Zhu.

Additional information

Competing interests

The authors declare that there are no competing interests.

Authors’ contributions

WG carried out the data analysis and drafted the manuscript. RCE and XZ participated in the design of the study and coordination and edited the manuscript. All authors read and approved the final manuscript.

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

Guo, W., Elston, R.C. & Zhu, X. Evaluation of a LASSO regression approach on the unrelated samples of Genetic Analysis Workshop 17. BMC Proc 5 (Suppl 9), S12 (2011). https://doi.org/10.1186/1753-6561-5-S9-S12

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/1753-6561-5-S9-S12

Keywords