Abstract
Linear mixed models (LMMs) can be applied in the meta-analyses of responses from individuals across multiple contexts, increasing power to detect associations while accounting for confounding effects arising from within-individual variation. However, traditional approaches to fitting these models can be computationally intractable. Here, we describe an efficient and exact method for fitting a multiple-context linear mixed model. Whereas existing exact methods may be cubic in their time complexity with respect to the number of individuals, our approach for multiple-context LMMs (mcLMM) is linear. These improvements allow for large-scale analyses requiring computing time and memory magnitudes of order less than existing methods. As examples, we apply our approach to identify expression quantitative trait loci from large-scale gene expression data measured across multiple tissues as well as joint analyses of multiple phenotypes in genome-wide association studies at biobank scale.
Keywords: Meta-analysis, Linear mixed models, multiple-context genetic association
Keywords: Applied computing → Bioinformatics, Applied computing → Computational genomics
1. Introduction
Over the last decade, the scale of genomic datasets has steadily increased. These datasets have grown to the size of hundreds of thousands of individuals [3] with millions soon to come [21]. Similarly, datasets for transcriptomics and epigenomics are growing to thousands of samples [1, 5, 14]. These studies provide valuable insight into the relationship between our genome and complex phenotypes [23].
Identifying these associations requires statistical models that can account for biases in study design that can negatively influence results through false positives or decreased power. Linear mixed models (LMMs) have been a popular choice for controlling these biases in genomic studies, utilizing variance components to account for issues such as population stratification [8]. These models can also be used to analyze studies with repeated measurements from individuals, such as replicates or measurements across different contexts. Meta-Tissue [20] is a method that applies this model in the context of identifying expression quantitative trait loci (eQTLs) across multiple tissues. In this framework, gene expression is measured in several tissues from the same individuals and the LMM is utilized to test the association between these values and genotypes. A meta-analytic approach is used to combined effects across multiple tissues to increase the power of detecting eQTLs. This approach has also been applied to increase power in genome-wide association studies (GWAS) by testing the association between genotypes and multiple related phenotypes [7].
However, these approaches are computationally intensive. Existing approaches for fitting these models are cubic in time complexity with respect to the number of samples across all contexts [8, 26]. Here, we present an ultra-fast LMM framework specifically for multiple-context studies. Our method, mcLMM, is linear in complexity with respect to the number of individuals and allows for statistical tests in a manner of hours rather than days or years with existing approaches. To illustrate the computational efficiency of mcLMM, we compare the runtime and memory usage of our method with EMMA and GEMMA [8, 26], two popular approaches for fitting these models. We further apply mcLMM to identify a large number of eQTLs in the Genotype-Tissue Expression (GTEx) dataset [5] and compare our results from METASOFT [6], which performs the meta-analysis of the mcLMM output, to a recent meta-analytic approach known as mash [22]. Finally, to demonstrate the practicality of mcLMM on modern datasets, we perform a multiple-phenotype GWAS combining over a million observations sampled from hundreds of thousands of individuals in the UK Biobank [3] within hours.
2. Methods
2.1. Linear Mixed Model
For multiple-context experiments with n individuals, t contexts, and c covariates, we fit the following linear mixed model
(1) |
Where is a vectorized representation of the responses, is the matrix of covariates, is the vector of estimated coefficients is a binary matrix where indicates that sample i and sample j in Y come from the same individual, and is an identity matrix. X is structured such that both an intercept and the covariate effects are fit within each context. For sake of simplicity, dimensions of nt assume that there is no missing data; however, this is not a requirement for the model. We note that this definition of K models within-individual variability as a random-effect, while within-context or across-individual variability is not included.
The full and restricted log-likelihood functions for this model are
(2) |
(3) |
where N is the total number of measurements made across the individuals and contexts and [24]. These likelihood functions are maximized with the generalized least squares estimator and in the full log-likelihood and in the restricted log-likelihood, where Our goal is to maximize these likelihood functions to estimate the optimal .
2.2. Likelihood refactoring in the general case
The EMMA algorithm optimizes these likelihoods for δ by refactoring them in terms of constants calculated from eigendecompositions of H and SHS, where , that allow linear complexity optimization iterations with respect to the number of individuals [8]. The GEMMA algorithm further increases efficiency by replacing the SHS eigendecomposition with a matrix-vector multiplication [26]. Both approaches require the eigendecomposition of at least one N by N matrix which is typically cubic in complexity. Here, we show that our specific definition of K as a binary indicator matrix allows us to refactor these likelihood functions without any eigendecomposition steps. It should be noted that EMMA and GEMMA can fit this model for any positive semidefinite K, while mcLMM is restricted to the definition described above.
We note that previous work has shown similar speedups when the matrix K is low rank and has a block structure as described here [10]. This work, FaST-LMM, shows that the likelihood functions can be computed in linear time with respect to the number of individuals after singular value decomposition of a matrix with complexity that is also linear with respect to the number of individuals. We improve upon these methods by recognizing that the eigenvalues of the K matrix are known beforehand, which allows for further efficiency in fitting this model. Furthermore, the FaST-LMM model assumes that all individuals within each context share additional covariance while mcLMM assumes that all contexts observed within an individual share additional covariance.
First, note that H = K+δI is a block diagonal matrix. Specifically, each block corresponds to an individual i with ti contexts measured, where ti is less than or equal to t depending on the number of contexts observed for individual i. Each block is equal to where 1ti is a ti by ti matrix composed entirely of 1. These properties of H make its eigendecomposition and inverse directly known.
The eigenvalues of a block diagonal matrix are equal to the union of the eigenvalues of each block. Moreover, the eigenvalues of are with multiplicity 1 and δ with multiplicity ti - 1. Therefore, H has eigenvalues δ with multiplicity N - n and ti + δ for each ti. This provides our first refactoring
(4) |
The inverse of a block diagonal matrix can also be computed by inverting each block individually. Moreover, using the Sherman-Morrison formula [16], the inverse of [1ti + δIti] is known
(5) |
Given each entry of H−1, we can show algebraically that
(6) |
(7) |
(8) |
where f (i) = i%t (modulo operator) provides the context of a given 0-indexed column of X, g(i) = i//t (integer division) provides the covariate of a given index. A group g defines the set of individuals that share the same number of measured contexts tg. The expression “ind indicates the set of all individuals that have tg measured contexts that include context i and j.
Note that with all values independent of δ pre-computed, specifically the sum of covariate interactions within the sets of individuals indicated above, E is constant with respect to δ and each entry of the symmetric matrix D can be calculated in linear time with respect to the number of groups, which is less than or equal to the number of contexts t. For a given δ, we can compute XTH−1X in O(t(tc)2) time complexity. Both the restricted and full log-likelihoods require the calculation of (XTH−1X)−1. The restricted log-likelihood requires the additional calculation of . To calculate both of these terms, we perform a Cholesky decomposition of , where * indicates the conjugate transpose. Given this decomposition, we can compute
(9) |
(10) |
These operations can be done in O((tc)3) time complexity.
Let P(X) denote a projection matrix and M(X) = (I — P(X)). Note that both P(X) and M (X) are idempotent. The term remaining term in the likelihood functions, R, can be reformulated as follows
(11) |
(12) |
(13) |
The scalar a and vector b are a function of δ and can be algebraically formulated as
(14) |
(15) |
where indicates the sum of responses across all contexts for an individual. With values independent of δ pre-calculated, a and b can be calculated in linear time with respect to the number of groups.
Note that Equations 16 and 17 remove terms that are independent of δ since they are not required for finding its optimal value, indicated by the ≈ symbol. We can reformulate the entire likelihood functions as follows
(16) |
(17) |
These likelihoods are maximized for using the optimize function in R. Each likelihood evaluation has a time complexity of O((tc)3 + n).
2.3. Likelihood refactoring with no missing data
When there is no missing data, the likelihood functions can be further simplified. Note that in this case, N = nt and all ti = t. Hence,
(18) |
If the input terms y, X, and K are permuted resulting in samples being sorted in order of context, and the covariates in X are sorted in order of context, we can decompose H and X into
(19) |
(20) |
where indicates the Kronecker product and is a typical representation of the covariates for each individual without multiple contexts (i.e. samples as rows and covariates as columns). Utilizing the properties of Kronecker products, we can perform the following reformulation
(21) |
(22) |
Note that the remaining determinant in Equation 22 will not need to be calculated since it is independent of δ. Next, we show that is independent of δ.
(23) |
This form of shows that the optimal coefficients are equivalent to fitting separate ordinary least squares (OLS) models for each context. We compute by concatenating these OLS estimates. Given this term, we can also compute the residuals of this model and reformulate R as follows.
(24) |
The term denotes the sum of residuals for an individual across all contexts. Let and .
(25) |
Now we can reformulate the log-likelihoods, omitting terms that do not depend on δ.
(26) |
(27) |
Both functions are differentiable with respect to δ. Moreover, both derivatives have the same root
(28) |
The scalar values u and v can be calculated by performing a separate OLS regression for each context, which can be completed in O(t(nc2 + c3)) time for a naive OLS implementation. Compared to the methods described above, this approach requires no iterative optimization and the estimate is optimal. Our implementation has a time complexity of O(c3 + nc2 + tcn).
2.4. Resource requirement simulation comparison
We installed EMMA v1.1.2 and manually built GEMMA from its GitHub source (genetics-statistics/GEMMA.git, commit 9c5dfbc). We edited the source code of GEMMA to prevent the automatic addition of intercept term in the design matrix (commented out lines 1946 to 1954 of src/param.cpp).
Data were simulated using the mcLMM package. Sample sizes of 100, 200, 300, 400, and 500 were simulated with 50 contexts. Context sizes of 4, 8, 16, 32, and 64 were simulated with 500 samples. Data were simulated with and and a sampling rate of 0.5. Memory usage of each method was measured using the peakRAM R package (v 1.0.2).
2.5. False positive rate simulation
We simulated gene expression levels in multiple tissues for individuals where there were no eQTLs. In other words, gene expression levels were not affected by any SNPs. We considered 10,000 genes and 100 SNPs resulting in one million gene-SNP pairs. We simulated 1,000 individuals. We also examined false positive rates with 500 and 800 individuals. We generated 49 such datasets where the number of tissues varied from 2 to 50. To simulate the genotypes for each subject, we randomly generated two haplotypes (vectors consisting of 0 and 1) assuming a minor allele frequency (MAF) of 30%. To simulate gene expression levels from multiple tissues among the same individuals, we sampled gene expression from the following multivariate normal distribution:
(29) |
where y is an N × T vector representing the gene expression levels of N individuals in T tissues and K is an NT × NT matrix corresponding the correlation between the subjects across the tissues. Ki,j = 1 when i and j are from two tissues of the same individuals, Ki,j = 0 otherwise. Here, we let . We used a custom R function (included with the mcLMM package) to simulate data from this distribution, which is based on sampling with a smaller covariance matrix for each block of measurements from an individual.
After generating the simulation datasets, we first ran mcLMM to obtain the estimated effect sizes and their standard errors, as well as the correlation matrices. The results from mcLMM were used as the input of METASOFT for meta-analysis to evaluate the significance. False positive rate was calculated as the proportion of gene-SNP pairs with p-values smaller than the significance level (α = 0.05).
2.6. True positive simulations
We developed the true positive simulation framework based on a previous study describing mash [22]. We simulated effects for 20,000 gene-SNP pairs in 44 tissues, 400 of which have non-null effects (true positives) and 19,600 of which have null effects. Let (βjr denote the effects of the gene-SNP pair j in context/tissue r and βj is a vector of effects across various tissues, including null effects and non-null effects. We simulated the gene expression levels for 1,000 individuals as:
(30) |
where X denotes the genotypes of the individuals that were simulated as described in the false positive rate simulation. , which is similar to the simulation in the false positive rate simulation. For βj, we defined two types of non-null effects and simulated them in different ways:
▀ Shared, structured effects: non-null effects are shared in all tissues and the sharing is structured. The non-null effects are similar in effect sizes and directions (up-regulation or down-regulation) across all tissues, and this similarity would be stronger among some subsets of tissues. For 19,600 null effects, we set βj = 0. For 400 non-null effects, we assumed that each βj independently followed a multivariate normal distribution with mean 0 and variance wUk, where k is an index number randomly sample from 1, . . . , 8. represents a scaling factor to help capture the full range of effects. Uk are 44 × 44 data-driven covariance matrices learned from the GTEx dataset, which are provided in [22].
▀ Shared, unstructured effects: non-null effects are shared in all tissues but the sharing is unstructured or independent across different tissues. For 19,600 null effects, we set βj = 0. For 400 non-null effects, we sampled βj from a multivariate normal distribution with mean of 0 and variance of 0.01I, where I is a 44 × 44 identity matrix.
After simulating the gene expression levels y, we first ran mcLMM on the simulated datasets to acquire the estimated effect sizes and their standard errors, as well as the correlation matrices. We then applied METASOFT for meta-analysis with mcLMM outputs to evaluate the significance. For mash, we first performed simple linear regression to get the estimates of the effects and their standard errors in each tissue separately. These estimates and standard errors were used as the inputs for mash, which returned the measure of significance for each effect, the local false sign rate (lfsr). Finally, we employed the “pROC” R package [15] to calculate the receiver operating characteristic (ROC) curve and area under the ROC curve with the significance measures (p-values for mcLMM and METASOFT, lfsr for mash) and the correct labels of null effects and non-null effects.
2.7. Analysis of the GTEx dataset
The Genotype-Tissue Expression (GTEx) v8 dataset [5] was used in this study. We down-loaded the gene expression data, the summary statistics of single-tissue cis-eQTL data using a 1 MB window around each gene, and the covariates in the eQTL analysis from GTEx portal (https://gtexportal.org/home/datasets). The subject-level genotypes were acquired from dbGaP accession number phs000424.v8.p2. The GTEx v8 dataset includes 49 tissues from 838 donors. We selected 15,627 genes that were expressed in all 49 tissues. We only included SNPs with minor allele frequency (MAF) greater than 1% and missing rate lower than 5%. We applied mash and mcLMM plus METASOFT to the GTEx v8 dataset in our analysis.
Since mash requires observation of the correlation structure among non-significant tests and data-driven covariance matrices before fitting its model, we prepared its input by selecting the top SNP with the smallest p-value and 49 random SNPs (or all other SNPs if there were fewer than 49 SNPs left in a gene) in every gene from the eQTL analysis in the GTEx v8 dataset. There were 560,475 gene-SNP pairs in total. mash uses the estimated effect sizes and standard errors of these gene-SNP pairs to learn the correlation structure of different conditions/tissues. We used the top significant SNPs to set up the data-driven covariances. We then fit mash to the random set of gene-SNP pairs with the canonical and data-driven covariances. With the fitted mash model, we computed the posterior summaries including local false sign rate (lfsr) [18] for the selected gene-SNP pairs to estimate the significance. We defined significant gene-SNP pairs as those with lfsr < 0.05 in any tissues.
We applied mcLMM to the same set of gene-SNP pairs. We regressed out unwanted confounding factors in gene expression levels for each tissue with a linear model using covariates provided by GTEx. Covariates of each sample included top 5 genotyping principal components, PEER factors [17] (15 factors for tissues with fewer than 150 samples, 30 factors for those with 150–250 samples, 45 factors for those with 250–350 samples, and 60 factors for those with more than 350 samples), sequencing platform, and sex. We ran mcLMM with the genotypes and processed gene expression levels of all 838 individuals across 49 GTEx tissues for each gene-SNP pair. Missing values in gene expression were included in the mcLMM input. The effect sizes, standard errors, and correlation matrices estimated by mcLMM were meta-analyzed with METASOFT to evaluate the significance under both the fixed effects (FE) and random effects (RE2) models. The resulting p-values were converted to q-values [19] to control false discovery rates. A gene-SNP pair was considered significant if its false discovery rate (FDR) was smaller than 5%.
2.8. Analysis of the UK Biobank dataset
This work was conducted using the UK Biobank Resource under application 33127. Samples were filtered for Caucasian individuals (Data-Field 22006)). Hard imputed genotype data from the UK Biobank were LD pruned using a window size of 50, step size of 1, and correlation threshold of 0.2. SNPs were further filtered for minor allele frequency of at least 0.01 and a Hardy-Weinberg equilibrium p-value greater than 1e-7 using Plink 2 [4]. Samples were filtered for unrelated individuals with KING using a cutoff value of 0.125 [11]. Genotype data were split by chromosome and converted to bigsnpr format (v 1.4.4) for memory efficiency [12].
The following data fields were retrieved: age at recruitment (Data-Field 31), sex (Data-Field 21022), BMI (Data-Field 23104), body fat percentage (Data-Field 23099), 10 genetic principal components (Data-Field 22009), HDL Cholesterol (Data-Field 30760), LDL Direct (Data-Field 30780), Apolipoprotein A (Data-Field 30630), Apolipoprotein B (Data-Field 30640), and Triglycerides (Data-Field 30870). Continuous phenotypes were visually inspected and triglycerides were log-transformed due to skewness. Data were filtered for complete observations. All fields were scaled to unit variance and centered at 0.
HDL cholesterol, LDL cholesterol, Apolipoprotein A, Apolipoprotein B, and triglycerides were combined as response variables in the LMM and age, sex, BMI, body fat percentage, and the top 10 genetic principal components were used as additional covariates in the model. Each SNP was marginally fit with mcLMM. The coefficients output by this model for each phenotype were meta-analyzed to calculate FE p-values using METASOFT as packaged with Meta-Tissue v 0.5. The top GWAS hits for five different chromosomes (one per chromosome) were validated using the NHGRI-EBI GWAS catalog [2] and compared to studies for LDL and HDL cholesterol (GCST008035 and GCST008037).
3. Results
3.1. mcLMM is computationally efficient
To demonstrate the efficiency of mcLMM compared to existing approaches, we applied our method to simulated data of varying sample sizes and number of contexts. For these simulations, we simulated a sampling rate of 0.5, which indicates that only half of all possible individual-context pairs of observations are expected to be sampled.
We first applied our method to simulations with a fixed number of 50 contexts and varied the sample size from 100 to 500. From these experiments, we observed that mcLMM requires computational time orders of magnitude less than EMMA and GEMMA. Similarly, when we fixed the number of samples at 500 and varied the context sizes from 4 to 64, we observed dramatically reduced runtimes for mcLMM.
In these experiments, mcLMM also significantly reduces the memory footprint compared to EMMA and GEMMA, since we avoid creating any nt by nt matrices. In these simulations, existing approaches quickly grow memory requirements, with usages that grow to dozens of gigabytes for modestly sized datasets in the thousands of samples. mcLMM allows large-scale studies to be performed on relatively little computational resources (Figure 1).
In cases where there is no missing data, mcLMM allows for further speedups. We ran similar simulations to compare mcLMM with no missing data (optimal model) and mcLMM with missing data (iterative model). We observed a dramatic speedup, with sample sizes of 500,000 individuals across 10 contexts completed in under 10 seconds for the optimal model compared to around 15 minutes for the iterative model.
3.2. mcLMM enables powerful meta analyses to detect eQTLs
We utilized mcLMM to reduce the computational resource requirements of the Meta-Tissue pipeline, which fits a multiple-context LMM and combines the resulting effect sizes using METASOFT [20]. While powerful, the existing approach utilizes EMMA to fit the LMM. For a recent release from the GTEx consortium [5], each pair of genes and single nucleotide polymorphisms (SNPs) required over two hours to run. Across hundreds of thousands of gene-SNP pairs, this method would require years of computational runtime to complete. Utilizing mcLMM, we were able to complete this analysis in 3 days parallelized over each chromosome.
We compared our approach to a method known as mash [22]. This approach utilizes effect sizes estimated within each context independently and employs a Bayesian approach to combine their results for meta-analysis. In order to estimate the power of these methods, we performed simulations as described in the methods. In null simulations, we observed well-controlled false positive rates at α = 0.05 for mcLMM coupled with METASOFT. In our simulation with true positives, we observed an increased area under the receiver operating characteristic (AUROC) for mcLMM coupled with the random effects (RE2) METASOFT model compared to mash (Figure 2).
Next, we compared the number of significant associations identified in the GTEx dataset. The mash approach utilized gene-SNP effect sizes estimated by the GTEx consortium within each tissue independently. Concordant with our simulations, we observed that the Meta-Tissue approach, utilizing mcLMM for vast speedup, identified more significant eQTLs than mash (Figure 3). These associations allow researchers to better understand the link between genetic variation and complex phenotypes through possible mediation of gene expression.
3.3. mcLMM scales to millions of samples across related phenotypes
As a practical application of the efficiency of mcLMM, we performed a multiple phenotype GWAS in the UK Biobank. A multiple phenotype GWAS associates SNPs with several related phenotypes in order to increase the effective sample size for greater power, under the assumption that the phenotypes are significantly correlated. For our analysis, we combined HDL and LDL cholesterol, Apolipoprotein A and B, and triglyceride levels across 323,266 unrelated caucasian individuals in the UK Biobank. In total, 1,616,330 observations of these related phenotypes were fit as responses in the LMM.
The mcLMM approach completed this analysis over 211,642 SNPs with an additional 14 covariates, parallelized over each chromosome, within a day. Each chromosome was analyzed on a single core machine with 32 GB of memory, with each test taking around 2 seconds to complete. We identified several significant loci, a subset of which replicate previous findings for specific phenotypes included in the model, such as HDL cholesterol [25] (Figure 4). Existing approaches, namely EMMA and GEMMA, require orders of magnitude more memory to begin this analyses and could not be run on the available computational resources.
4. Discussion
We presented mcLMM, an efficient method for fitting LMMs used for multiple-context association studies. Our method provides exact results and scales linearly in time and memory with respect to sample size, while existing methods are cubic. This efficiency allows mcLMM to process hundreds of thousands of samples over several contexts within a day on minimal computational resources, as we showed in simulation and in the UK Biobank. The association parameters learned by mcLMM can further be utilized with the METASOFT framework to provide powerful meta-analysis of the associations, as we showed in the GTEx dataset.
Previous approaches have derived related speedups for LMMs when the matrix K is low rank, such as in the case when multiple samples are genetically identical or clustered in genome wide association studies as described in FaST-LMM [10]. In this approach, the authors show that the likelihood function can be evaluated in linear time with respect to the number of individuals after singular value decomposition of a matrix that is also linear with respect to the number of individuals. Other work has similarly used block structures and Kronecker refactorizations in studies with structured designs, such as multi-trait GWAS, to significantly speed up these approaches as well [9, 13].
Our approach builds upon these findings and we optimize the method specifically for the low rank matrix with known eigenvalues described in the model, thus avoiding any spectral or singular value decompositions. Furthermore, when there is no missing data, our method can compute the optimal model parameters with a closed form solution requiring no iterative optimization of likelihood functions. We also note that mcLMM models covariance across contexts within an individual while the FaST-LMM approach, described above, models covariance across individuals within each context. This specific model fit by mcLMM arises in multiple-context association studies, such as the approach employed by Meta Tissue [20] for identifying eQTLs across tissues utilizing the cubic EMMA algorithm. Applied within this framework for eQTL and multi-trait genome wide association studies, our method provides exact results and scales to hundreds of thousands of samples with minimal computational resources.
Acknowledgments
Funding Brandon Jew: National Science Foundation Graduate Research Fellowship Program under Grant No. DGE-1650604.
Sriram Sankararaman: NIH R35GM125055, Alfred P. Sloan Research Fellowship, NSF III-1705121, CAREER 1943497.
Jae Hoon Sul: National Institute of Environmental Health Sciences (NIEHS) [K01 ES028064]; the National Science Foundation grant [#1705197]; the National Institute of Neurological Disorders and Stroke (NINDS) [R01 NS102371]; and NINDS [R03 HL150604].
Footnotes
Supplementary Material mcLMM is available as an R package at https://github.com/brandonjew/mcLMM.
Contributor Information
Brandon Jew, Bioinformatics Interdepartmental Program, University of California, Los Angeles, USA.
Jiajin Li, Department of Human Genetics, University of California, Los Angeles, USA.
Sriram Sankararaman, Department of Human Genetics, University of California, Los Angeles, USA; Department of Computer Science, University of California, Los Angeles, USA; Department of Computational Medicine, University of California, Los Angeles, USA.
Jae Hoon Sul, Department of Psychiatry and Biobehavioral Sciences, University of California, Los Angeles, USA.
References
- 1.Aguet François, Brown Andrew A., Castel Stephane E., Davis Joe R., He Yuan, Jo Brian, Mohammadi Pejman, Park YoSon, Parsana Princy, Segrè Ayellet V., Strober Benjamin J., Zappala Zachary, Cummings Beryl B., Gelfand Ellen T., Hadley Kane, Huang Katherine H., Lek Monkol, Li Xiao, Nedzel Jared L., Nguyen Duyen Y., Noble Michael S., Sullivan Timothy J., Tukiainen Taru, MacArthur Daniel G., Getz Gad, Addington Anjene, Guan Ping, Koester Susan, Little A. Roger, Lockhart Nicole C., Moore Helen M., Rao Abhi, Struewing Jeffery P., Volpi Simona, Brigham Lori E., Hasz Richard, Hunter Marcus, Johns Christopher, Johnson Mark, Kopen Gene, Leinweber William F., Lonsdale John T., McDonald Alisa, Mestichelli Bernadette, Myer Kevin, Roe Bryan, Salvatore Michael, Shad Saboor, Thomas Jeffrey A., Walters Gary, Washington Michael, Wheeler Joseph, Bridge Jason, Foster Barbara A., Gillard Bryan M., Karasik Ellen, Kumar Rachna, Miklos Mark, Moser Michael T., Jewell Scott D., Montroy Robert G., Rohrer Daniel C., Valley Dana, Mash Deborah C., Davis David A., Sobin Leslie, Barcus Mary E., Branton Philip A., Abell Nathan S., Balliu Brunilda, Delaneau Olivier, Frésard Laure, Gamazon Eric R., Garrido-Martín Diego, Gewirtz Ariel D. H., Gliner Genna, Gloudemans Michael J., Han Buhm, He Amy Z., Hormozdiari Farhad, Li Xin, Liu Boxiang, Yong Kang Eun, McDowell Ian C., Ongen Halit, Palowitch John J., Peterson Christine B., Quon Gerald, Ripke Stephan, Saha Ashis, Shabalin Andrey A., Shimko Tyler C., Hoon Sul Jae, Teran Nicole A., Tsang Emily K., Zhang Hailei, Zhou Yi-Hui, Bustamante Carlos D., Cox Nancy J., Guigó Roderic, Kellis Manolis, McCarthy Mark I., Conrad Donald F., Eskin Eleazar, Li Gen, Nobel Andrew B., Sabatti Chiara, Stranger Barbara E., Wen Xiaoquan, Wright Fred A., Ardlie Kristin G., Dermitzakis Emmanouil T., Lappalainen Tuuli, Handsaker Robert E., Kashin Seva, Karczewski Konrad J., Nguyen Duyen T., Trowbridge Casandra A., Barshir Ruth, Basha Omer, Battle Alexis, Bogu Gireesh K., Brown Andrew, Brown Christopher D., Chen Lin S., Chiang Colby, Damani Farhan N., Engelhardt Barbara E., Ferreira Pedro G., Gewirtz Ariel D.H., Guigo Roderic, Hall Ira M., Howald Cedric, Kyung Im Hae, Yong Kang Eun, Kim Yungil, Kim-Hellmuth Sarah, Mangul Serghei, Monlong Jean, Montgomery Stephen B., Muñoz-Aguirre Manuel, Ndungu Anne W., Nicolae Dan L., Oliva Meritxell, Panousis Nikolaos, Papasaikas Panagiotis, Payne Anthony J., Quan Jie, Reverter Ferran, Sammeth Michael, Scott Alexandra J., Sodaei Reza, Stephens Matthew, Urbut Sarah, van de Bunt Martijn, Wang Gao, Xi Hualin S., Yeger-Lotem Esti, Zaugg Judith B., Akey Joshua M., Bates Daniel, Chan Joanne, Claussnitzer Melina, Demanelis Kathryn, Diegel Morgan, Doherty Jennifer A., Feinberg Andrew P., Fernando Marian S., Halow Jessica, Hansen Kasper D., Haugen Eric, Hickey Peter F., Hou Lei, Jasmine Farzana, Jian Ruiqi, Jiang Lihua, Johnson Audra, Kaul Rajinder, Kibriya Muhammad G., Lee Kristen, Billy Li Jin, Li Qin, Lin Jessica, Lin Shin, Linder Sandra, Linke Caroline, Liu Yaping, Maurano Matthew T., Molinie Benoit, Nelson Jemma, Neri Fidencio J., Park Yongjin, Pierce Brandon L., Rinaldi Nicola J., Rizzardi Lindsay F., Sandstrom Richard, Skol Andrew, Smith Kevin S., Snyder Michael P., Stamatoyannopoulos John, Tang Hua, Wang Li, Wang Meng, Van Wittenberghe Nicholas, Wu Fan, Zhang Rui, Nierras Concepcion R., Carithers Latarsha J., Vaught Jimmie B., Gould Sarah E., Lockart Nicole C., Martin Casey, Addington Anjene M., Koester Susan E., GTEx Consortium, Lead analysts:, Data Analysis & Coordinating Center (LDACC): Laboratory, NIH program management:, Biospecimen collection:, Pathology:, eQTL manuscript working group:, Data Analysis & Coordinating Center (LDACC)-Analysis Working Group Laboratory, Statistical Methods groups-Analysis Working Group, Enhancing GTEx (eGTEx) groups, NIH Common Fund, NIH/NCI, NIH/NHGRI, NIH/NIMH, NIH/NIDA, and Biospecimen Collection Source Site-NDRI. Genetic effects on gene expression across human tissues. Nature, 550(7675):204–213, 10 2017. doi: 10.1038/nature24277. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 2.Buniello Annalisa, MacArthur Jacqueline A L, Cerezo Maria, Harris Laura W, Hayhurst James, Malangone Cinzia, McMahon Aoife, Morales Joannella, Mountjoy Edward, Sollis Elliot, Suveges Daniel, Vrousgou Olga, Whetzel Patricia L, Amode Ridwan, Guillen Jose A, Riat Harpreet S, Trevanion Stephen J, Hall Peggy, Junkins Heather, Flicek Paul, Burdett Tony, Hindorff Lucia A, Cunningham Fiona, and Parkinson Helen. The NHGRI-EBI GWAS Catalog of published genome-wide association studies, targeted arrays and summary statistics 2019. Nucleic Acids Research, 47(D1):D1005–D1012, 11 2018. arXiv:https://academic.oup.com/nar/article-pdf/47/D1/D1005/27437312/gky1120.pdf, doi: 10.1093/nar/gky1120. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 3.Bycroft Clare, Freeman Colin, Petkova Desislava, Band Gavin, Elliott Lloyd T., Sharp Kevin, Motyer Allan, Vukcevic Damjan, Delaneau Olivier, Jared O’Connell Adrian Cortes, Welsh Samantha, Young Alan, Effingham Mark, Gil McVean Stephen Leslie, Allen Naomi, Donnelly Peter, and Marchini Jonathan. The uk biobank resource with deep phenotyping and genomic data. Nature, 562(7726):203–209, 10 2018. doi: 10.1038/s41586-018-0579-z. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 4.Chang Christopher C, Chow Carson C, CAM Tellier Laurent, Vattikuti Shashaank, Purcell Shaun M, and Lee James J. Second-generation PLINK: rising to the chalenge of larger and richer datasets. GigaScience, 4(1), 02 2015. s13742–015-0047–8. arXiv:https://academic.oup.com/gigascience/article-pdf/4/1/s13742-015-0047-8/25512027A3742\_2015\_article\_47.pdf, doi: 10.1186/s13742-015-0047-8. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 5.Consortium GTEx. The GTEx consortium atlas of genetic regulatory effects across human tissues. Science, 369(6509):1318–1330, September 2020. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 6.Han Buhm and Eskin Eleazar. Random-effects model aimed at discovering associations in meta-analysis of genome-wide association studies. The American Journal of Human Genetics, 88(5):586–598, 05 2011. doi: 10.1016/j.ajhg.2011.04.014. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 7.Wha J Joo Jong, Yong Kang Eun, Org Elin, Furlotte Nick, Parks Brian, Hor- mozdiari Farhad, Lusis Aldons J, and Eskin Eleazar. Efficient and Accurate Multiple-Phenotype Regression Method for High Dimensional Data Considering Population Structure. Genetics, 204(4):1379–1390, 12 2016. arXiv:https://academic.oup.com/genetics/article-pdf/204/4/1379/36292201/genetics1379.pdf, doi: 10.1534/genetics.116.189712. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 8.Hyun Min Kang Noah A. Zaitlen, Wade Claire M., Kirby Andrew, Heckerman David, Daly Mark J., and Eskin Eleazar. Efficient control of population structure in model organism association mapping. Genetics, 178(3):1709–1723, 2008. doi: 10.1534/genetics.107.080101. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 9.Korte Arthur, Vilhjalmsson Bjarni J., Segura Vincent, Platt Alexander, Long Quan, and Nordborg Magnus. A mixed-model approach for genome-wide association studies of correlated traits in structured populations. Nature Genetics, 44(9):1066–1071, Sep 2012. doi: 10.1038/ng.2376. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 10.Lippert Christoph, Listgarten Jennifer, Liu Ying, Kadie Carl M., Davidson Robert I., and Heckerman David. Fast linear mixed models for genome-wide association studies. Nature Methods, 8(10):833–835, 10 2011. doi: 10.1038/nmeth.1681. [DOI] [PubMed] [Google Scholar]
- 11.Manichaikul Ani, Mychaleckyj Josyf C., Rich Stephen S., Daly Kathy, Sale Michèle, and Chen Wei-Min. Robust relationship inference in genome-wide association studies. Bioinformatics, 26(22):2867–2873, 10 2010. arXiv:https://academic.oup.com/bioinformatics/article-pdf/26/22/2867/16896963/btq559.pdf, doi: 10.1093/bioinformatics/btq559. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 12.Florian Privé Hugues Aschard, Ziyatdinov Andrey, and Blum Michael G B. Efficient analysis of large-scale genome-wide data with two R packages: bigstatsr and bigsnpr. Bioinformatics, 34(16):2781–2787, 03 2018. arXiv:https://academic.oup.com/bioinformatics/article-pdf/34/16/2781/25442043/bty185.pdf, doi: 10.1093/bioinformatics/bty185. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 13.Rakitsch Barbara, Lippert Christoph, Borgwardt Karsten, and Stegle Oliver. It is all in the noise: Efficient multi-task gaussian process inference with structured residuals. In Burges CJC, Bottou L, Welling M, Ghahramani Z, and Weinberger KQ, editors, Advances in Neural Information Processing Systems, volume 26. Curran Associates, Inc., 2013. URL: https://proceedings.neurips.cc/paper/2013/file/59c33016884a62116be975a9bb8257e3-Paper.pdf. [Google Scholar]
- 14.Rakyan Vardhman K., Down Thomas A., Balding David J., and Beck Stephan. Epigenome-wide association studies for common human diseases. Nature reviews. Genetics, 12(8):529–541, 07 2011. 21747404[pmid]. doi: 10.1038/nrg3000. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 15.Robin Xavier, Turck Natacha, Hainard Alexandre, Tiberti Natalia, Lisacek Frédérique, Sanchez Jean-Charles, and Markus Müller. pROC: an open-source package for R and s+ to analyze and compare ROC curves. BMC Bioinformatics, 12:77, March 2011. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 16.Sherman Jack and Morrison Winifred J. Adjustment of an Inverse Matrix Corresponding to a Change in One Element of a Given Matrix. The Annals of Mathematical Statistics, 21(1):124–127, 1950. doi: 10.1214/aoms/1177729893. [DOI] [Google Scholar]
- 17.Stegle Oliver, Parts Leopold, Piipari Matias, Winn John, and Durbin Richard. Using probabilistic estimation of expression residuals (PEER) to obtain increased power and interpretability of gene expression analyses. Nat. Protoc, 7(3):500–507, February 2012. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 18.Stephens Matthew. False discovery rates: a new deal. Biostatistics, 18(2):275–294, 2017. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 19.Storey John D. A direct approach to false discovery rates. Journal of the Royal Statistical Society: Series B (Statistical Methodology), 64(3):479–498, 2002. URL: https://rss.onlinelibrary.wiley.com/doi/abs/10.1111/1467-9868.00346, arXiv: https://rss.onlinelibrary.wiley.com/doi/pdf/10.1111/1467-9868.00346, doi: 10.1111/1467-9868.00346. [DOI] [Google Scholar]
- 20.Jae Hoon Sul Buhm Han, Ye Chun, Choi Ted, and Eskin Eleazar. Effectively identifying eqtls from multiple tissues by combining mixed model and meta-analytic approaches. PLOS Genetics, 9(6):1–13, 06 2013. doi: 10.1371/journal.pgen.1003491. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 21.The All of Us Research Program Investigators. The “all of us” research program. New England Journal of Medicine, 381(7):668–676, 2019. PMID: 31412182. arXiv: 10.1056/NEJMsr1809937, doi: 10.1056/NEJMsr1809937. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 22.Urbut Sarah M., Wang Gao, Carbonetto Peter, and Stephens Matthew. Flexible statistical methods for estimating and testing effects in genomic studies with multiple conditions. Nature Genetics, 51(1):187–195, 01 2019. doi: 10.1038/s41588-018-0268-8. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 23.Visscher Peter M., Brown Matthew A., Mark I. McCarthy, and Jian Yang. Five years of gwas discovery. American journal of human genetics, 90(1):7–24, 01 2012. 22243964[pmid]. doi: 10.1016/j.ajhg.2011.11.029. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 24.Welham SJ and Thompson R. Likelihood ratio tests for fixed model terms using residual maximum likelihood. Journal of the Royal Statistical Society: Series B (Statistical Methodology), 59(3):701–714, 1997. doi: 10.1111/1467-9868.00092. [DOI] [Google Scholar]
- 25.Wojcik Genevieve L., Graff Mariaelisa, Nishimura Katherine K., Tao Ran, Haessler Jeffrey, Gignoux Christopher R., Highland Heather M., Patel Yesha M., Sorokin Elena P., Avery Christy L., Belbin Gillian M., Bien Stephanie A., Cheng Iona, Cullina Sinead, Hodonsky Chani J., Hu Yao, Huckins Laura M., Jeff Janina, Justice Anne E., Kocarnik Jonathan M., Lim Unhee, Lin Bridget M., Lu Yingchang, Nelson Sarah C., Park Sung-Shim L., Poisner Hannah, Preuss Michael H., Richard Melissa A., Schurmann Claudia, Setiawan Veronica W., Sockell Alexandra, Vahi Karan, Verbanck Marie, Vishnu Abhishek, Walker Ryan W., Young Kristin L., Zubair Niha, Victor Acuña-Alonso Jose Luis Ambite, Barnes Kathleen C., Boerwinkle Eric, Bottinger Erwin P., Bustamante Carlos D., Caberto Christian, Samuel Canizales-Quinteros Matthew P. Conomos, Deelman Ewa, Do Ron, Doheny Kimberly, Lindsay Fernández-Rhodes Myriam Fornage, Hailu Benyam, Heiss Gerardo, Henn Brenna M., Hindorff Lucia A., Jackson Rebecca D., Laurie Cecelia A., Laurie Cathy C., Li Yuqing, Lin Dan-Yu, Andres Moreno-Estrada Girish Nadkarni, Norman Paul J., Pooler Loreall C., Reiner Alexander P., Romm Jane, Sabatti Chiara, Sandoval Karla, Sheng Xin, Stahl Eli A., Stram Daniel O., Thornton Timothy A., Wassel Christina L., Wilkens Lynne R., Winkler Cheryl A., Yoneyama Sachi, Buyske Steven, Haiman Christopher A., Kooperberg Charles, Loic Le Marchand Ruth J. F. Loos, Matise Tara C., North Kari E., Peters Ulrike, Kenny Eimear E., and Carlson Christopher S. Genetic analyses of diverse populations improves discovery for complex traits. Nature, 570(7762):514–518, 06 2019. doi: 10.1038/s41586-019-1310-4. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 26.Zhou Xiang and Stephens Matthew. Genome-wide efficient mixed-model analysis for association studies. Nature Genetics, 44(7):821–4, 2012. doi: 10.1038/ng.2310. [DOI] [PMC free article] [PubMed] [Google Scholar]