Abstract
Motivation
In a genome-wide association study, analyzing multiple correlated traits simultaneously is potentially superior to analyzing the traits one by one. Standard methods for multivariate genome-wide association study operate marker-by-marker and are computationally intensive.
Results
We present a sparsity constrained regression algorithm for multivariate genome-wide association study based on iterative hard thresholding and implement it in a convenient Julia package MendelIHT.jl. In simulation studies with up to 100 quantitative traits, iterative hard thresholding exhibits similar true positive rates, smaller false positive rates, and faster execution times than GEMMA’s linear mixed models and mv-PLINK’s canonical correlation analysis. On UK Biobank data with 470 228 variants, MendelIHT completed a three-trait joint analysis () in 20 h and an 18-trait joint analysis () in 53 h with an 80 GB memory footprint. In short, MendelIHT enables geneticists to fit a single regression model that simultaneously considers the effect of all SNPs and dozens of traits.
Availability and implementation
Software, documentation, and scripts to reproduce our results are available from https://github.com/OpenMendel/MendelIHT.jl.
1 Introduction
Current statistical methods for genome-wide association studies (GWAS) can be broadly categorized as single variant or multi-variant in their genomic predictors. Multi-variant sparse models ignore polygenic background and assume that only a small number of single-nucleotide polymorphisms (SNPs) are truly causal for a given trait. Model fitting is typically accomplished via regression with penalties, such as the least absolute shrinkage and selection operator (LASSO) (Wu et al. 2009, Zhou et al. 2010b, 2011, Alexander and Lange 2011, Qian et al. 2020), minimax concave penalty (Zhang 2010, Breheny and Huang 2011), iterative hard thresholding (IHT) (Keys et al. 2017, Chu et al. 2020), or Bayesian analogues (Guan and Stephens 2011). Linear mixed models (LMMs) dominate the single-variant space. LMMs control for polygenic background while focusing on the effect of a single SNP. LMMs are implemented in the contemporary programs GEMMA (Zhou and Stephens 2012), BOLT (Loh et al. 2018), GCTA (Yang et al. 2011, Jiang et al. 2019), and SAIGE (Zhou et al. 2018). The virtues of the various methods vary depending on the genetic architecture of a trait. No method is judged uniformly superior (Galesloot et al. 2014).
Although there is no consensus on the best modeling framework for single-trait GWAS, there is considerable support for analyzing multiple correlated traits jointly rather than separately (Galesloot et al. 2014, Porter and O’Reilly 2017, Turchin and Stephens 2019). When practical, joint analysis (i) incorporates extra information on cross-trait covariances, (ii) distinguishes between pleiotropic and independent SNPs, (iii) reduces the burden of multiple testing, and (iv) ultimately increases statistical power. Surprisingly, simulation studies suggest these advantages hold even if only one of multiple traits is associated with a SNP or if the correlation among traits is weak (Galesloot et al. 2014). These advantages motivate this article and our search for an efficient method for analyzing multivariate traits.
Existing methods for multivariate-trait GWAS build on the polygenic model or treat SNPs one by one. For instance, GEMMA (Zhou and Stephens 2014) implements multivariate linear mixed models (mvLMM), mv-PLINK (Ferreira and Purcell 2009) implements canonical correlation analysis (CCA), and MultiPhen (O’Reilly et al. 2012) and Scopa (Mägi et al. 2017) invert regression so that the genotypes at a single SNP become the trait and observed traits become predictors. Due to their single-variant nature, these methods cannot distinguish whether a SNP exhibits a true effect on the trait or a secondary association mediated by linkage disequilibrium (LD). As a result, many correlated SNPs near the causal one are also selected. This inflates the false positive (FP) rate unless one applies fine-mapping strategies (Spain and Barrett 2015) in downstream analysis to distill the true signal. Joint regression methods like IHT and LASSO are less susceptible to finding SNPs with only secondary association because all SNPs are considered simultaneously.
To our knowledge, there are no sparse regression methods for multivariate-trait GWAS. In this article, we extend IHT (Blumensath and Davies 2009) to the multivariate setting and implement it in the Julia (Bezanson et al. 2017) package MendelIHT.jl, part of the larger OpenMendel statistical genetics ecosystem (Zhou et al. 2020). We have previously demonstrated the virtues of IHT compared to LASSO regression, and single-SNP analysis for univariate GWAS (Keys et al. 2017, Chu et al. 2020). Since IHT assumes sparsity and focuses on mean effects, it is ill-suited to capture polygenic background as represented in classic variance components models. In the sequel, we first describe our generalization of IHT. Then, we study the performance of IHT on simulated traits given real genotypes. These simulations explore the impact of varying the sparsity level k and the number of traits r. To demonstrate the potential of IHT on real large-scale genomic data, we also apply it to three hypertension-related traits and 18 metabolomic traits from the UK Biobank. Our simulation experiments and real data studies showcase IHT’s speed, low FP rate, and scalability to large numbers of traits. Our concluding discussion summarizes our main findings, limitations of IHT, and questions worthy of future research.
2 Materials and methods
2.1 Model development
Consider multivariate linear regression with r quantitative traits and p predictors. Up to a constant, the loglikelihood for n independent subjects is
(1) |
The loglikelihood is a function of the regression coefficients matrix and the unstructured precision (inverse covariance) matrix . In Equation (1), is the matrix of traits (responses), and is the design matrix (genotypes plus non-genetic predictors). All predictors are treated as fixed effects.
IHT maximizes subject to the constraints that k or fewer entries of are non-zero and that is symmetric and positive definite. The unknown parameter k is chosen via cross-validation. Optimizing with respect to for fixed relies on three core ideas. The first is gradient ascent. Elementary calculus tells us that the gradient is the direction of steepest ascent of at for fixed. IHT updates in the steepest ascent direction by the formula , where m is iteration number, is an optimally chosen step length, and is the current value of the pair . The gradient is derived in the online supplementary material as the matrix
(2) |
The second core idea dictates how to choose the step length . This is accomplished by expanding the function in a second-order Taylor series around . In the online supplementary material, we show that the optimal for this quadratic approximant is where abbreviates the gradient . The third core idea of IHT involves projecting the steepest ascent update to the sparsity set . The projection operator sets to zero all but the largest k entries in magnitude of . This goal can be achieved efficiently by a partial sort on the vectorized version of . For all predictors to be treated symmetrically in projection, they should be standardized to have mean 0 and variance 1. Likewise, in cross-validation of k with mean square error prediction, it is a good idea to standardize all traits.
(3) |
To update the precision matrix for fixed, we take advantage of the gradient spelt out in the online supplementary material. At a stationary point where , the optimal is
(4) |
(5) |
Equation (5) preserves the symmetry and positive semidefiniteness of . The required matrix inversion is straightforward unless the number of traits r is exceptionally large. Our experiments suggest solving for exactly is superior to running full IHT jointly on both and . Algorithm 1 displays our block ascent algorithm.
2.2 Linear algebra with compressed genotype matrices
We previously described how to manipulate PLINK files using the OpenMendel module SnpArrays.jl (Zhou et al. 2020), which supports linear algebra on compressed genotype matrices (Chu et al. 2020). We now outline several enhancements to our compressed linear algebra routines.
Compact genotype storage and fast reading. A binary PLINK genotype (Purcell et al. 2007) stores each SNP genotype in two bits. Thus, an genotype matrix requires 2np bits of memory. For bit-level storage Julia (Bezanson et al. 2017) supports the 8-bit unsigned integer type (UInt8) that can represent four sample genotypes simultaneously in a single 8-bit integer. Extracting sample genotypes can be achieved via bitshift and bitwise and operations. Genotypes are stored in little-endian fashion, with 0, 1, 2, and missing genotypes mapped to the bit patterns 00, 10, 11, and 01, respectively. For instance, if a locus has four sample genotypes 1, 0, 2, and missing, then the corresponding UInt8 integer is 01110010 in binary representation. Finally, because the genotype matrix is memory-mapped, opening a genotype file and accessing data are fast even for very large files.
Single instruction, multiple data (SIMD)-vectorized and tiled linear algebra. In IHT, the most computationally intensive operations are the matrix-vector and matrix-matrix multiplications required in computing gradients. To accelerate these operations, we employ SIMD vectorization and tiling. On machines with SIMD support, such as Advanced Vector Extensions, our linear algebra routine on compressed genotypes is usually twice as fast as Basic Linear Algebra Subroutines (BLAS) 2 (Lawson et al. 1979) calls with an uncompressed numeric matrix and comparable in speed to BLAS 3 calls if is tall or flat. These benchmarks are available on GitHub https://github.com/OpenMendel/SnpArrays.jl/blob/master/docs/SnpLinAlg.ipynb.
Computation of the matrix product requires special care when is the binary PLINK-formatted genotype matrix and and are numeric matrices. The idea is to partition these three matrices into small blocks and exploit the representation by computing each tiled product in parallel. Because entries of a small matrix block are closer together in memory, this strategy improves cache efficiency. The triple for loops needed for computing products are accelerated by invoking Julia’s LoopVectorization.jl package, which performs automatic vectorization on machines with SIMD support. Furthermore, this routine can be parallelized because individual blocks can be multiplied and added independently. Because multi-threading in Julia is composable, these parallel operations can be safely nested inside other multi-threading Julia functions, such as IHT’s cross-validation routine.
2.3 Simulated data experiments
Our simulation studies are based on the Chromosome 1 genotype data of the Northern Finland Birth Cohort (NFBC) (Sabatti et al. 2009). The original NFBC1966 data contain 5402 subjects and 364 590 SNPs; 26 906 of the SNPs reside on Chromosome 1. After filtering for subjects with at least 98% genotype success rate and SNPs with missing data <2%, we ended with 5340 subjects and 24 523 SNPs on Chromosome 1. For r traits, traits are simulated according to the matrix normal distribution (Dawid 1981, Yin and Li 2012, Furlotte and Eskin 2015) as using the OpenMendel module TraitSimulation.jl (Ji et al. 2021). Here, is the Chromosome 1 NFBC genotype matrix with n subjects aligned along its columns. The matrix contains the true regression coefficients uniformly drawn from and randomly set to 0 so that entries survive. In standard mathematical notation, . Note, the effect-size set is comparable to previous studies (Chu et al. 2020). To capture pleiotropic effects, SNPs are randomly chosen to impact two traits. The remaining causal SNPs affect only one trait. Thus, . Note, it is possible for two traits to share 0 pleiotropic SNPs. The row (trait) covariance matrix is simulated so that its maximum condition number does not exceed 10. The column (sample) covariance matrix equals , where is the centered genetic relationship matrix estimated by GEMMA (Zhou and Stephens 2014). We let and . Different combinations of r, , and are summarized in Table 1. Each combination is replicated 100 times. It is worth emphasizing that this generative model should favor LMM analysis.
Table 1.
Time (s) | Plei power | Indep power | FP | |
---|---|---|---|---|
Set 1: (2 traits, ) | ||||
mIHT | ||||
uIHT | ||||
CCA | ||||
mvLMM | ||||
Set 2: (3 traits, ) | ||||
mIHT | ||||
uIHT | ||||
CCA | ||||
mvLMM | ||||
Set 3: (5 traits, ) | ||||
mIHT | ||||
uIHT | ||||
CCA | ||||
mvLMM | ||||
Set 4: (10 traits, ) | ||||
mIHT | ||||
uIHT | ||||
CCA | ||||
mvLMM | ||||
Set 5: (50 traits, ) | ||||
mIHT | ||||
uIHT | ||||
CCA | (*) | NA | NA | NA |
mvLMM | NA | NA | NA | NA |
Set 6: (100 traits, ) | ||||
mIHT | ||||
uIHT | ||||
CCA | NA | NA | NA | NA |
mvLMM | NA | NA | NA | NA |
Traits were simulated consistent with the Chromosome 1 SNPs of the NFBC1966 data. Plei power is power for pleiotopic SNPs, Indep power is power for independent SNPs, and FP is the total number of FPs, which potentially includes variants in high LD. Fig. 1 repeats the same simulation with LD-pruning. Displayed numbers are mean SDs. is the total number of non-zero entries in , is the number of independent SNPs affecting only one trait, and is the number of pleiotropic SNPs affecting two traits. These numbers satisfy . Each simulation relied on 100 replicates. NA: >24 h. (*) Only two replicates contribute to timing.
Finally, using PLINK (Purcell et al. 2007), we generated three additional datasets by filtering out all SNPs whose pairwise correlation exceeds 0.25, 0.5, and 0.75. This action resulted in 7594, 13 441, and 18 580 SNPs, respectively. These reduced sets of data are used to study the effect of LD on power and FP rates in our subsequent comparisons of the competing methods.
2.4 Method comparisons
In our simulation experiments, we compared multivariate IHT (mIHT) to running multiple separate univariate IHT (uIHT) analyses (Keys et al. 2017, Chu et al. 2020), CCA implemented in mv-PLINK (Ferreira and Purcell 2009), and mvLMM implemented in GEMMA (Zhou and Stephens 2014). The LMM software GEMMA is broadly popular in genetic epidemiology. The software mv-PLINK is chosen for its speed. A recent review (Galesloot et al. 2014) rates it as the second fastest of the competing programs. The fastest method, mvBIMBAM (Stephens 2013), is an older method published by the authors of GEMMA, so it is not featured in this study.
In simulated data experiments, all programs were run within 16 cores of an Intel Xeon Gold 6140 2.30 GHz CPU with access to 32 GB of RAM. All experiments relied on version 1.4.2 of MendelIHT and Julia v1.5.4. IHT’s sparsity level k is tuned by cross-validation. The number of cross-validation paths is an important determinant of both computation time and accuracy. Thus, for simulated data, we employed an initial grid search involving 5-fold cross-validation over the sparsity levels . This was followed by 5-fold cross-validation for . This strategy first searches the space of potential values broadly, then, zooms in on the most promising candidate sparsity level. GEMMA and mv-PLINK were run under their default settings. For both programs, we declared SNPs significant whose P-values were lower than .05 divided by the number of SNPs tested. For GEMMA, we used the Wald test statistic.
2.5 Quality control for UK Biobank
We conducted two separate MendelIHT.jl analyses on the second release of the UK Biobank (Sudlow et al. 2015), containing subjects and SNPs. Our first analysis deals with three hypertension traits: average systolic blood pressure (SBP), average diastolic blood pressure (DBP), and body mass index (BMI). Our second analysis deals with 18 metabolomic quantitative traits related to total lipidomics.
All traits were first log-transformed to minimize the impact of skewness. Then each trait was standardized to mean 0 and variance 1, so that the traits were treated similarly in mean-squared error (MSE) cross-validation. Following Chu et al. (2020), German et al. (2020), and Ko et al. (2022a), we first filtered subjects exhibiting sex discordance, high heterozygosity, or high SNP missingness. We then excluded subjects of non-European ancestry and first and second-degree relatives based on empirical kinship coefficients. For three-trait hypertension analysis, we also excluded subjects on hypertension medicine at baseline. Finally, we excluded subjects with genotyping success rate and SNPs with genotyping success rate and imputed the remaining missing genotypes by the corresponding sample-mean genotypes. Note that imputation occurs in IHT on-the-fly.
The final dataset contains 470 228 SNPs and 185 656 subjects for the three hypertension traits and 104 264 subjects for the metabolomics traits. Given these reduced data and ignoring the Biobank’s precomputed principal components, we computed afresh the top 10 principal components of the genotype matrix via FlashPCA2 (Abraham et al. 2017) for the three-trait analysis and ProPCA (Agrawal et al. 2020) for the 18-trait analysis. These principal components serve as predictors to adjust for hidden ancestry. We also designated sex, age, and age2 as non-genetic predictors.
3 Results
3.1 Simulation experiments
Table 1 summarizes the various experiments conducted on the simulated data. For IHT, 5-fold cross-validation times are included. mIHT is the fastest method across the board and the only one that can analyze more than 50 traits. mIHT’s runtime increases roughly linearly with the number of traits and, as demonstrated previously, with sample size as well (Chu et al. 2020). All methods perform similarly in recovering the pleiotropic and independent SNPs. uIHT exhibits slightly worse true positive rate compared to multivariate methods. Given the identically distributed effect sizes in our simulations, all methods are better at finding pleiotropic SNPs than independent SNPs.
In Table 1, the number of FPs for both univariate and mIHT are much lower than competing methods. Presumably, many of the FPs from mvLMM and CCA represent SNPs in significant LD with the causal SNP. To study this phenomenon more closely, we repeated simulations in Sets 1–4 with LD-pruning of SNPs based on pairwise correlations (see Section 2 on how this is done prior to simulation). Figure 1 displays the number of FPs based on three separate LD-pruned datasets. Power comparison plots are available in the online supplementary material. IHT is better at distilling the true signal within these LD blocks, with or without LD-pruning, because IHT considers the effect of all SNPs jointly. Also mvLMM is better at controlling FPs than CCA, but mvLMM is slower, especially for large numbers of traits. In summary, IHT offers better model selection than its competitors with better computational speed.
3.2 Three-trait UK Biobank analysis
With three hypertension traits, the UK Biobank analysis completed in 20 h and 8 min on 36 cores of an Intel Xeon Gold 6140 2.30 GHz CPU with access to 180 GB of RAM. As described in the methods section, the featured traits are BMI, average SBP, and average DBP. A first pass with 3-fold cross-validation across model sizes showed that minimizes the MSE. A second pass with 3-fold cross-validation across model sizes showed that minimizes the MSE. A third 3-fold cross-validation pass across identified as the best sparsity level. Given , we ran mIHT on the full data to estimate effect sizes, correlation among traits, and proportion of phenotypic variance explained by the genotypes.
IHT selected 13 pleiotropic SNPs and 171 independent SNPs. Selected SNPs and non-genetic predictors appear in Supplementary Tables S1–S5. To compare against previous studies, we used the R package gwasrapidd (Magno and Maia 2020) to search the NHGRI-EBI GWAS catalog (MacArthur et al. 2017) for previously associated SNPs within 1 Mb of each IHT discovered SNP. After matching, all 13 pleiotropic SNPs and 158 independent SNPs are either previously associated or are within 1 Mb of a previously associated SNP. We discovered 3 new associations with SBP and 10 new associations associated with DBP. Seven SNPs, rs2307111, rs6902725, rs11977526, rs2071518, rs11222084, rs365990, and rs77870048, are associated with two traits in opposite directions.
One can estimate the genotypic variance explained by the sparse model as for each trait where is the ith row of . MendelIHT.jl outputs the values , , and . Note these estimates do not include contributions from the intercept or non-genetic predictors. The estimated correlations among traits are , , and . As expected, all traits are positively correlated, with a strong correlation between SBP and DBP and a weak correlation between BMI and both SBP and DBP.
3.3 18-Trait UK Biobank analysis
A separate analysis of the 18 UK Biobank lipid traits finished in 53 h on 32 cores of an AMD EPYC 7502P 2.5 GHz CPU with access to 252 GB of RAM. The peak RAM usage was 80.1 GB as measured by the seff command available on slurm clusters. Our cross-validation search started with an initial grid of and eventually terminated with . The IHT run-time script with its detailed cross-validation path is available in the online supplementary material.
mIHT found 218 independent and 699 pleiotropic SNPs for the 18 lipid traits. On average, a pleiotropic SNP is associated with 6.4 distinct lipid traits, suggesting that most significant SNPs for total lipid level are highly pleiotropic. Figure 2 depicts estimated effect sizes. The complete list of effect sizes as well as the estimated trait covariance matrix can be downloaded from our software page. The proportion of variance explained for each trait [roughly estimated as ] appears in the online supplementary material.
Although all traits are related to total lipids, we observe many associated genes containing distinct SNPs with opposite effects. Some of these reversals are caused by negatively correlated traits. Others are byproducts of IHT estimating the effect size of the alternate allele rather than that of the reference allele. Interestingly, SNP rs7679 has a large negative effect for Very Large HDL but a large positive effect for Small HDL, despite the fact that the two traits are positively correlated. To verify this phenomenon, we conducted 18 univariate regressions considering only rs7679 plus an intercept. The result confirmed that this SNP indeed affects the two traits in opposite directions. SNPs, such as rs7679, are interesting candidates for follow-up studies.
4 Discussion
This article presents mIHT for analyzing multiple correlated traits. In simulation studies, mIHT exhibits similar true positive rates, significantly lower FP rates, and better overall speed than LMMs and CCA. Computational time for mIHT increases roughly linearly with the number of traits. Since IHT is a multivariate regression method, the estimated effect size for each SNP is explicitly conditioned on other SNPs and non-genetic predictors. Analyzing three correlated UK Biobank traits with subjects and SNPs took 20 h on a single machine. A separate 18-trait analysis with subjects and SNPs took 53 h. IHT can output the correlation matrix and a rough estimate of the proportion of variance explained for the component traits. MendelIHT.jl also automatically handles various input formats (binary PLINK, BGEN, and VCF files) by calling the relevant OpenMendel packages. If binary PLINK files are used, MendelIHT.jl avoids decompressing genotypes to full numeric matrices.
MendelIHT.jl’s superior speed is partly algorithmic and partly due to software/hardware optimization. Internally, each iteration of mIHT requires a small Cholesky factorization, where r is the number of traits. Each iteration also requires a dense matrix–matrix multiplication for computing gradients. For featured in this study, the factorization is trivial to compute. To speed up matrix multiplication, we developed a parallelized, tiled, and SIMD-vectorized kernel that directly operates on binary PLINK files. This key innovation allows us to achieve performance near BLAS 3 calls without decompressing genotypes to numeric matrices. Because this kernel can be safely nested within IHT’s parallelized cross-validation step, we believe MendelIHT.jl is capable of utilizing hundreds of compute cores on a single machine.
IHT’s statistical and computational advantages come with limitations. For instance, it does not deliver P-values and ignores hidden and explicit relatedness. IHT can exploit principal components to adjust for ancestry, but PCA alone is insufficient to account for small-scale family structure (Price et al. 2010). To overcome this limitation, close relatives can be excluded from a study. Additional simulations summarized in Supplementary Table S7 also suggest that analyzing traits of vastly different polygenic heritability may lead to slightly inflated FP rates for the less polygenic traits. Thus, researchers may need to exercise caution when using mIHT for multiple traits when polygenic heritability differs by more than an order of magnitude. Although our simulation studies suggest the contrary, there is also the possibility that strong LD may confuse IHT. Finally, it is unclear how IHT will respond to wrongly imputed markers, extreme trait outliers, and the rare variants generated by sequencing. In spite of these qualms, the evidence presented here is persuasive about IHT’s potential for multivariate GWAS.
We will continue to explore improvements to IHT. Extension to non-Gaussian traits is hindered by the lack of flexible multivariate distributions with non-Gaussian margins. Cross-validation remains computationally intensive in tuning the sparsity level k. Although our vectorized linear algebra routine partially overcomes many of the computational barriers, we feel that further gains are possible through GPU computing (Zhou et al. 2010a, Ko et al. 2020, 2021, 2022b). In model selection, it may also be possible to control FDR better with statistical knockoff strategies (Barber and Candès 2015, Sesia et al. 2021), especially if traits of vastly varying polygenicity are being considered. Given IHT’s advantages, we recommend it for general use with the understanding that genetic epidemiologists respect its limitations and complement its application with standard univariate statistical analysis.
Supplementary Material
Acknowledgements
The UCLA Institute for Digital Research and Education’s Research Technology Group supplied computational and storage services through its Hoffman2 Shared Cluster.
Contributor Information
Benjamin B Chu, Department of Computational Medicine, David Geffen School of Medicine at UCLA, Los Angeles, CA 90095-1554, United States.
Seyoon Ko, Department of Computational Medicine, David Geffen School of Medicine at UCLA, Los Angeles, CA 90095-1554, United States; Department of Biostatistics, Fielding School of Public Health at UCLA, Los Angeles, CA 90095-1554, United States.
Jin J Zhou, Department of Biostatistics, Fielding School of Public Health at UCLA, Los Angeles, CA 90095-1554, United States; Department of Medicine, David Geffen School of Medicine at UCLA, Los Angeles, CA 90095-1554, United States.
Aubrey Jensen, Department of Biostatistics, Fielding School of Public Health at UCLA, Los Angeles, CA 90095-1554, United States.
Hua Zhou, Department of Computational Medicine, David Geffen School of Medicine at UCLA, Los Angeles, CA 90095-1554, United States; Department of Biostatistics, Fielding School of Public Health at UCLA, Los Angeles, CA 90095-1554, United States.
Janet S Sinsheimer, Department of Computational Medicine, David Geffen School of Medicine at UCLA, Los Angeles, CA 90095-1554, United States; Department of Biostatistics, Fielding School of Public Health at UCLA, Los Angeles, CA 90095-1554, United States; Department of Human Genetics, David Geffen School of Medicine at UCLA, Los Angeles, CA 90095-1554, United States.
Kenneth Lange, Department of Computational Medicine, David Geffen School of Medicine at UCLA, Los Angeles, CA 90095-1554, United States; Department of Human Genetics, David Geffen School of Medicine at UCLA, Los Angeles, CA 90095-1554, United States; Department of Statistics at UCLA, Los Angeles, CA 90095-1554, United States.
Supplementary data
Supplementary data is available at Bioinformatics online.
Conflict of interest
None declared.
Funding
This work was partially supported by National Institutes of Health [T32-HG02536 to B.B.C., R01-HG006139 to B.B.C., K.L., and H.Z., R35 GM141798 to K.L., J.S.S., and H.Z., R01-HG009120 to J.S.S., K01DK106116 to J.J.Z., R21HL150374 to J.J.Z.]; National Science Foundation [DMS-1264153 to J.S.S., DMS-2054253 to H.Z. and J.J.Z., IIS-2205441 to H.Z. and J.J.Z.]; and a National Research Foundation of Korea (NRF) grant [2020R1A6A3A03037675 to S.K.] from the Korean government.
Data availability
The Northern Finland Birth Cohort 1966 (NFBC1966) was downloaded from dbGaP under dataset accession pht002005.v1.p1. UK Biobank data are retrieved under Project ID: 48152 and 15678.
References
- Abraham G, Qiu Y, Inouye M. et al. FlashPCA2: principal component analysis of Biobank-scale genotype datasets. Bioinformatics 2017;33:2776–8. [DOI] [PubMed] [Google Scholar]
- Agrawal A, Chiu AM, Le M. et al. Scalable probabilistic PCA for large-scale genetic variation data. PLoS Genet 2020;16:e1008773. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Alexander DH, Lange K.. Stability selection for genome-wide association. Genet Epidemiol 2011;35:722–8. [DOI] [PubMed] [Google Scholar]
- Barber RF, Candès EJ.. Controlling the false discovery rate via knockoffs. Ann Statist 2015;43:2055–85. [Google Scholar]
- Bezanson J, Edelman A, Karpinski S. et al. Julia: a fresh approach to numerical computing. SIAM Rev 2017;59:65–98. [Google Scholar]
- Blumensath T, Davies ME.. Iterative hard thresholding for compressed sensing. Appl Comput Harmon Anal 2009;27:265–74. [Google Scholar]
- Breheny P, Huang J.. Coordinate descent algorithms for nonconvex penalized regression, with applications to biological feature selection. Ann Appl Stat 2011;5:232–53. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Chu BB, Keys KL, German CA. et al. Iterative hard thresholding in genome-wide association studies: generalized linear models, prior weights, and double sparsity. GigaScience 2020;9:giaa044. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Dawid AP. Some matrix-variate distribution theory: notational considerations and a Bayesian application. Biometrika 1981;68:265–74. [Google Scholar]
- Ferreira MA, Purcell SM.. A multivariate test of association. Bioinformatics 2009;25:132–3. [DOI] [PubMed] [Google Scholar]
- Furlotte NA, Eskin E.. Efficient multiple-trait association and estimation of genetic correlation using the matrix-variate linear mixed model. Genetics 2015;200:59–68. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Galesloot TE, van Steen K, Kiemeney LALM. et al. A comparison of multivariate genome-wide association methods. PLoS One 2014;9:e95923. [DOI] [PMC free article] [PubMed] [Google Scholar]
- German CA, Sinsheimer JS, Klimentidis YC. et al. Ordered multinomial regression for genetic association analysis of ordinal phenotypes at Biobank scale. Genet Epidemiol 2020;44:248–60. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Guan Y, Stephens M.. Bayesian variable selection regression for genome-wide association studies and other large-scale problems. Ann Appl Stat 2011;5:1780–815. [Google Scholar]
- Ji SS, German CA, Lange K. et al. Modern simulation utilities for genetic analysis. BMC Bioinformatics 2021;22:1–13. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Jiang L, Zheng Z, Qi T. et al. A resource-efficient tool for mixed model association analysis of large-scale data. Nat Genet 2019;51:1749–55. [DOI] [PubMed] [Google Scholar]
- Keys KL, Chen GK, Lange K. et al. Iterative hard thresholding for model selection in genome-wide association studies. Genet Epidemiol 2017;41:756–68. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Ko S, Hua Z, Jin Z, Joong-Ho W. DistStat.jl: towards unified programming for high-performance statistical computing environments in Julia. arXiv, arXiv:2010.16114, 2020.
- Ko S, German CA, Jensen A. et al. GWAS of longitudinal trajectories at biobank scale. Am J Hum Genet 2022a;109:433–45. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Ko S, Li GX, Choi H. et al. Computationally scalable regression modeling for ultrahigh-dimensional omics data with ParProx. Brief Bioinform 2021;22:bbab256. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Ko S, Zhou H, Zhou JJ. et al. High-performance statistical computing in the computing environments of the 2020s. Statist Sci 2022b;37:494–518. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Lawson CL, Hanson RJ, Kincaid DR. et al. Basic linear algebra subprograms for Fortran usage. ACM Trans Math Softw 1979;5:308–23. [Google Scholar]
- Loh P-R, Kichaev G, Gazal S. et al. Mixed-model association for biobank-scale datasets. Nat Genet 2018;50:906–8. [DOI] [PMC free article] [PubMed] [Google Scholar]
- MacArthur J, Bowler E, Cerezo M. et al. The new NHGRI-EBI Catalog of published genome-wide association studies (GWAS Catalog). Nucleic Acids Res 2017;45:D896–901. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Mägi R, Suleimanov YV, Clarke GM. et al. Scopa and META-SCOPA: software for the analysis and aggregation of genome-wide association studies of multiple correlated phenotypes. BMC Bioinformatics 2017;18:1–8. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Magno R, Maia A-T.. gwasrapidd: an R package to query, download and wrangle GWAS catalog data. Bioinformatics 2020;36:649–50. [DOI] [PMC free article] [PubMed] [Google Scholar]
- O’Reilly PF, Hoggart CJ, Pomyen Y. et al. MultiPhen: joint model of multiple phenotypes can increase discovery in GWAS. PLoS One 2012;7:e34861. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Porter HF, O’Reilly PF.. Multivariate simulation framework reveals performance of multi-trait GWAS methods. Sci Rep 2017;7:1–12. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Price AL, Zaitlen NA, Reich D. et al. New approaches to population stratification in genome-wide association studies. Nat Rev Genet 2010;11:459–63. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Purcell S, Neale B, Todd-Brown K. et al. Plink: a tool set for whole-genome association and population-based linkage analyses. Am J Hum Genet 2007;81:559–75. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Qian J, Tanigawa Y, Du W. et al. A fast and scalable framework for large-scale and ultrahigh-dimensional sparse regression with application to the UK Biobank. PLoS Genet 2020;16:e1009141. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Sabatti C, Service SK, Hartikainen A-L. et al. Genome-wide association analysis of metabolic traits in a birth cohort from a founder population. Nat Genet 2009;41:35–46. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Sesia M, Bates S, Candès E. et al. False discovery rate control in genome-wide association studies with population structure. Proc Natl Acad Sci USA 2021;118:e2105841118. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Spain SL, Barrett JC.. Strategies for fine-mapping complex traits. Hum Mol Genet 2015;24:R111–9. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Stephens M. A unified framework for association analysis with multiple related phenotypes. PLoS One 2013;8:e65245. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Sudlow C, Gallacher J, Allen N. et al. UK biobank: an open access resource for identifying the causes of a wide range of complex diseases of middle and old age. PLoS Med 2015;12:e1001779. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Turchin MC, Stephens M.. Bayesian multivariate reanalysis of large genetic studies identifies many new associations. PLoS Genet 2019;15:e1008431. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Wu TT, Chen YF, Hastie T. et al. Genome-wide association analysis by lasso penalized logistic regression. Bioinformatics 2009;25:714–21. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Yang J, Lee SH, Goddard ME. et al. GCTA: a tool for genome-wide complex trait analysis. Am J Hum Genet 2011;88:76–82. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Yin J, Li H.. Model selection and estimation in the matrix normal graphical model. J Multivar Anal 2012;107:119–40. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Zhang C-H. Nearly unbiased variable selection under minimax concave penalty. Ann Statist 2010;38:894–942. [Google Scholar]
- Zhou H, Alexander DH, Sehl ME et al. Penalized regression for genome-wide association screening of sequence data. Pac Symp Biocomput 2011;2011:106–17. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Zhou H, Lange K, Suchard MA. et al. Graphical processing units and high-dimensional optimization. Stat Sci 2010a;25:311–24. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Zhou H, Sehl ME, Sinsheimer JS. et al. Association screening of common and rare genetic variants by penalized regression. Bioinformatics 2010b;26:2375–82. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Zhou H, Sinsheimer JS, Bates DM. et al. OpenMendel: a cooperative programming project for statistical genetics. Hum Genet 2020;139:61–71. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Zhou W, Nielsen JB, Fritsche LG. et al. Efficiently controlling for case-control imbalance and sample relatedness in large-scale genetic association studies. Nat Genet 2018;50:1335–41. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Zhou X, Stephens M.. Efficient multivariate linear mixed model algorithms for genome-wide association studies. Nat Methods 2014;11:407–9. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Zhou X, Stephens M.. Genome-wide efficient mixed-model analysis for association studies. Nat Genet 2012;44:821–4. [DOI] [PMC free article] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.
Supplementary Materials
Data Availability Statement
The Northern Finland Birth Cohort 1966 (NFBC1966) was downloaded from dbGaP under dataset accession pht002005.v1.p1. UK Biobank data are retrieved under Project ID: 48152 and 15678.