Summary
Genetic correlation is an important parameter in efforts to understand the relationships among complex traits. Current methods that analyze individual genotype data for estimating genetic correlation are challenging to scale to large datasets. Methods that analyze summary data, while being computationally efficient, tend to yield estimates of genetic correlation with reduced precision. We propose SCORE (scalable genetic correlation estimator), a randomized method of moments estimator of genetic correlation that is both scalable and accurate. SCORE obtains more precise estimates of genetic correlations relative to summary-statistic methods that can be applied at scale; it achieves a reduction in standard error relative to LD-score regression (LDSC) and a reduction relative to high-definition likelihood (HDL) (averaged over all simulations). The efficiency of SCORE enables computation of genetic correlations on the UK Biobank dataset, consisting of K individuals and K SNPs, in a few h (orders of magnitude faster than methods that analyze individual data, such as GCTA). Across 780 pairs of traits in unrelated white British individuals in the UK Biobank, SCORE identifies significant genetic correlation between 200 additional pairs of traits over LDSC (beyond the 245 pairs identified by both).
Keywords: genetic correlation, pleiotropy, complex traits, method of moments, biobank
Introduction
Genetic correlation is an important parameter that quantifies the genetic basis that is shared across two traits. Estimates of genetic correlation can reveal pleiotropy, uncover novel biological pathways underlying diseases, and improve the accuracy of genetic prediction.1
While traditionally reliant on family studies, the availability of genome-wide genetic data has led to several approaches to estimate genetic correlation from these datasets.1 An important class of methods for estimating genetic correlation relies on computing the restricted maximum likelihood within a bi-variate linear mixed model (LMM), termed genomic restricted maximum likelihood (GREML).2, 3, 4, 5 However, current GREML methods are computationally expensive to be applied to large-scale datasets such as the UK Biobank.6
While GREML methods need individual-level data, several methods,7, 8, 9, 10, 11, 12 such as linkage disequilibrium (LD)-score regression (LDSC),7 have been proposed for estimating genetic correlation with genome-wide association study (GWAS) summary statistics. Although methods such as LDSC often have substantially reduced computational requirements relative to GREML, LDSC estimates tend to have large standard errors that increase further when there is a mismatch between the samples used to estimate summary statistics and the reference datasets that are used to estimate LD scores.13 High-definition likelihood (HDL),12 a more recent summary-statistic-based method, has been shown to be more precise relative to LDSC. HDL, however, requires computing a singular-value decomposition (SVD) of the LD matrix, which increases its runtime. Further, recent studies14,15 have shown that the accuracy of genetic correlation estimates can deteriorate when there is a mismatch between reference and sample data. Thus, it is critical to develop methods for estimating genetic correlation that can work directly with large individual-level datasets.
We propose, SCORE (scalable genetic correlation estimator), a randomized method of moments (MoM) estimator of genetic correlations among traits via individual genotypes that can scale to the dataset sizes typical of the UK Biobank. While SCORE can estimate the heritability of traits as well as the genetic correlation between pairs of traits, we focus on the problem of estimating genetic correlation in this work. SCORE achieves scalability by avoiding explicit computation of the genetic relationship matrix (GRM). Instead, we show that the genetic correlation can be computed by using a sketch of the genotype matrix, i.e., by multiplying the genotype matrix with a small number of random vectors.
In simulations, we show that SCORE yields accurate estimates of genetic correlation across a range of genetic architectures (with varying heritability, genetic correlation, and polygenicity). Relative to summary-statistic methods that can be applied to biobank-scale data, SCORE obtains a reduction in standard error of relative to LDSC and relative to HDL (averaged across all simulations). Further, SCORE can estimate genetic correlation on K SNPs in K unrelated white British individuals in a few h, orders of magnitude faster than methods that rely on individual data (GCTA-GREML and GCTA-HE). Analyzing 780 pairs of traits in unrelated white British individuals in the UK Biobank, the estimates of genetic correlation at common SNPs obtained by SCORE are largely concordant with those from LDSC (Pearson correlation ). Although 245 pairs of traits are identified as having significant genetic correlation by both methods (with a Bonferroni correction for the number of pairs of traits tested), the reduced standard error of estimates from SCORE leads to the discovery of significant genetic correlations between an additional 200 pairs of traits relative to LDSC. Finally, SCORE detects a significant positive correlation between serum liver enzyme levels (alanine [ALT] and aspartate aminotransferase [AST]) and coronary-artery-disease-related traits (angina and heart attack), suggesting that coronary artery disease and liver dysfunction harbor a shared genetic component.
Material and methods
Bi-variate linear mixed model
We describe our model in the general setting, where the traits are not observed on the same set of individuals. Assume we have individuals for trait 1 and individuals for trait 2 of which N individuals contain measurements for both the traits. We have defined to be the and matrices of standardized genotypes obtained by centering and scaling each column of the unstandardized genotype matrices and so that for all . Let denote the two vectors of phenotypes with size and , respectively. Additionally, we define an indicator matrix, , where when individual i among samples measured for the first phenotype and j in samples measured for the second phenotype refer to the same individual and 0 otherwise. We define to be vectors of SNP effect sizes of length M.
We assume the following model relating a pair of traits :
(Equation 1) |
For the SNP effects, we assume and
(Equation 2) |
Here, is an identity matrix, denotes the genetic variance associated with trait t , and denotes the genetic covariance. For the environmental effects, we assume and
(Equation 3) |
The genetic correlation parameter is defined as . Importantly, SCORE does not make additional assumptions on the distribution of the genetic effect sizes or the environmental noise.
Method of moments (MoM)
SCORE uses a method of moments (MoM) estimator to estimate the parameters .
Because the mean of and are zero, we focus on the covariance. The population covariance of the concatenated phenotypes is now
(Equation 4) |
Here, is the GRM for the samples observed for the first trait, while is the GRM for the samples for the second trait and is the GRM for pairs of samples across traits.
We obtain the MoM estimator by minimizing the sum of squared differences between the population and empirical covariances:
(Equation 5) |
The MoM estimator for the genetic covariance satisfies the normal equations
(Equation 6) |
where . Given the coefficients of the normal equations, we can solve analytically for and .
Given MoM estimates of the variance components, the MoM estimate of the genetic correlation is given by the plug-in estimate:
(Equation 7) |
SCORE: Scalable genetic correlation estimator
Naive computation of the MoM estimate of genetic covariance requires computing , which requires operations, where are the sample size of each of the traits.
To overcome this computational bottleneck, we replace with an unbiased randomized estimate: .16
Given B random vectors, , drawn independently from a distribution with zero mean and identity covariance, our estimator is given by:
We obtain the SCORE estimator by solving Equation 6 by replacing with .
Here, denotes the sum of the squared genotypes for individuals measured on both traits so that can be computed in time: . Computing requires multiplying the genotype matrices and with B vectors resulting in a runtime of . Leveraging the fact that each element of the genotype matrix takes values in the set , can be computed in time 17 (while the standardized genotypes are real-valued, SCORE computes the equivalent quantities by operating on the unstandardized genotype matrix to be able to leverage its discrete entries followed by subtracting the product of the mean of a SNP and random vectors and scaling by minor allele frequency [MAF]). Combined with our previous efficient estimators of the genetic variance components,18,19 we obtain an efficient estimator of .
In the setting where the two traits are measured on the same set of individuals, we can estimate the directly without the need for separately estimating , , and . This estimator does not rely on any randomized approximations and can be computed in time . We term this modification (supplemental material and methods).
Simulations to assess accuracy
We performed simulations on a subset of unrelated white British individuals from the UK Biobank so that all methods compared could be run in a reasonable time. Our simulations used SNPs with MAF above (we chose these SNPs because these were also used for benchmarking the HDL12 method and had reference eigenvectors available).
Given the genotypes, we simulated pairs of traits under varying genetic architectures. Our first set of architectures assume an infinitesimal model (where all variants have a non-zero effect on both traits). We varied genetic correlation across and the heritability of the pair of traits, , across values of corresponding to the situation where both traits have low heritability, one trait has low while the other has moderate heritability, both traits have moderate heritability, and both have high heritability.
Our next set of non-infinitesimal architectures explore traits with medium polygenicity and low polygenicity. For each SNP m, we specify a causal status, , which is a vector with entries taking values in according to whether SNP m has a non-zero effect on each of the two traits. For medium polygenicity, causal status at SNP m is drawn independently according to the following distribution: , , and .
The effect size of SNP m on each trait is drawn from the following distribution:
For low polygenicity, we set the probability , , and .
The effect size for genetic variant m on both traits are drawn from the following distribution:
We vary across . Under this model, the true total expected genome-wide genetic correlation for medium polygenicity is and for low polygenicity. Unless specified otherwise, we assume complete sample overlap and no environmental correlation, set the environmental variance so that the trait variance is 1, and simulate a total of 100 replicates for each architecture.
Simulations to assess the impact of sample overlap
We simulated traits under an infinitesimal architecture with and 0.5. For each trait, we fixed the sample size to 5,000 and varied the proportion of sample overlap across (ranging from no overlap to complete overlap). Specifically, for overlap proportion equal to 0, we have 5,000 samples with observations on the first trait and a distinct set of 5,000 samples with observations on the second trait. For overlap proportion equal to 1, we have 5,000 samples with observations on both traits. We estimated genetic correlation with SCORE, LDSC, and GCTA-GREML.
Simulations to assess accuracy for binary traits
Given unrelated white British individuals in the UK Biobank measured on genetic variants, we simulated pairs of traits under an infinitesimal architecture setting and while varying the environmental correlation across .
To simulate binary traits, we converted the second trait to a binary trait by thresholding the underlying continuous trait such that the prevalence varied across .
Data processing
LD scores were computed from SNPs chosen for the simulations. The LD scores were computed from a random subset of individuals in the UK Biobank (the individuals used in our simulations were a subset of the individuals used for computation of LD score). For analysis of UK Biobank data, LD scores were computed on common SNPs (MAF ) present on the UK Biobank Axiom array. LD scores were computed with flags and .
Summary statistics input to LDSC were generated with PLINK. We used linear regression to generate summary statistics for continuous traits and categorical traits and logistic regression for binary traits. In computing summary statistics for traits in the UK Biobank, we include the following covariates: age, gender, principal components 1–10, assessment center, and genotype measurement batch. We used the same covariates as input to SCORE.
We ran LDSC under default settings with an unconstrained intercept. In addition to summary statistics, HDL requires eigenvectors of the LD matrix. We used the eigenvectors that preserve of the variance of the LD blocks that were released by the study authors. Computation of the eigenvectors used the same set of genetic variants as our simulations and samples in the UK Biobank.12
Quality control of UK Biobank data
We restricted our analysis to SNPs genotyped on the UK Biobank Axiom array, filtering out markers that had high missingness rate and low MAF , and we exclude the major histocompatibility complex (MHC) region. Moreover, SNPs that fail the Hardy-Weinberg equilibrium (HWE) test at significance threshold were removed. We also filter the samples that have a genetic kinship with any other sample (samples having any relatives in the dataset using the field 22021: “Genetic kinship to other participants”) and restricted the study to samples with self-reported British white ancestry (field 21000 with coding 1001). After quality control, we obtained individuals and SNPs.
We performed similar quality control on the imputed genotypes in the UK Biobank: filtering out markers with high missingness rate , low MAF , and HWE p value and that fall within the MHC region. After quality control, we obtained SNPs.
We chose traits that have missingness and disease traits with prevalence larger than , resulting in a total of 40 phenotypes consisting of 14 binary traits, three categorical traits, and 23 continuous traits. The 40 phenotypes could be classified into nine groups: glucose metabolism and diabetes, socioeconomic and general medical information, environmental factor, coronary artery disease related, autoimmune disorders, psychiatric disorders, anthropometric, blood pressure and circulatory, and lipid metabolism (Table S10).
Results
Accuracy and robustness of SCORE in simulations
We performed simulations to compare the accuracy of SCORE to other estimators of genetic correlation under different genetic architectures. Specifically, we compared SCORE to methods that use individual data (bi-variate GREML,2 bi-variate Haseman-Elston regression) and methods that rely on summary statistics (LD-score regression [LDSC]7 and HDL12). Bi-variate GREML (GCTA-GREML) and Haseman-Elston regression (GCTA-HE) are implemented in the GCTA software. LDSC is a widely used method to estimate genetic correlation when only summary statistics from GWASs on pairs of traits are available. HDL is a recent summary-statistics-based method that has been shown to obtain improved statistical efficiency relative to LDSC given additional information about LD. We ran all methods on the same set of SNPs to ensure a fair comparison.
We performed simulations to assess the estimation accuracy of each method by using a subset of 5,000 unrelated white British individuals in the UK Biobank so that all the methods could be run in a reasonable time. Unless otherwise specified, all our simulations used SNPs with MAF above . We simulated pairs of traits under a total of 48 genetic architectures: varying heritability of the pair of traits , genetic correlation , and polygenicity (proportion of causal variants shared and unique to each trait).
The simulations assume that the two traits are measured on the same set of individuals so that both SCORE and SCORE-OVERLAP can be applied in this setting. Because SCORE is a randomized estimator, we first examined the choice of the number of random vectors (B) on the estimates of . First, we confirmed that SCORE (with and random vectors) and SCORE-OVERLAP yield nearly identical results across the 48 architectures (Table S1). Second, we ran SCORE with different choices of random vectors on a single replicate that was simulated under the infinitesimal architecture with trait heritability , and . We observe that the standard deviation of estimates across choices of random vectors is about of the total standard error (SE), indicating that the choice of makes a modest contribution to variability in estimates. These results lead us to use SCORE with as our default.
Across the 48 architectures that we examined, the SE of SCORE ranges from 0.89 to 1.17 relative to the SE of GCTA-GREML; the SE of SCORE is higher than that of GCTA-GREML on average (Figures 1). Interestingly, GCTA-HE tends to have an SE that is 1.38 times that of SCORE on average (range 1.2 to 1.6). Compared to methods that rely on summary statistics, LDSC has 1.8 times the SE of SCORE on average (range 1.08 to 2.63), while the SE of HDL relative to SCORE is 1.24 (range 1.05 to 1.65) (Figure 1, Table S2). The reduction in the SE of SCORE relative to the summary-statistic-based methods is equivalent to a 3.24-fold increase in sample size over LDSC and a 1.56-fold increase in sample size over HDL on average. We find that the accuracy of SCORE relative to the other methods is consistent across infinitesimal (Figure S1) and non-infinitesimal architectures (Figure S2 for medium and Figure S3 for low polygenicity; the bias, SE, and mean squared error (MSE) of each of the methods is listed in Tables S3, S4, and S5). We additionally investigated the accuracy of each of the methods across a larger sample size of unrelated white British individuals chosen so that it was computationally feasible to run all methods, including GCTA-GREML and GCTA-HE. Under a non-infinitesimal architecture with medium polygenicity, and . In this larger sample size, we observe that SEs of GCTA-GREML, GCTA-HE, and LDSC are , and 2.85 times that of SCORE, respectively, consistent with our results on a .
We performed additional simulations to investigate the robustness of SCORE. First, we investigated the impact of sample overlap under an infinitesimal genetic architecture with . The SE of SCORE relative to GCTA-GREML and LDSC remains stable as a function of sample overlap (Figure S4 and Table S6 for the bias, SE, and MSE of SCORE, GCTA-GREML, and LDSC as a function of sample overlap). Second, we verified that the Jackknife standard error estimate used in SCORE is generally accurate while being conservative for low trait heritability (Table S7). Third, we verified the false positive rate of SCORE is controlled in simulations where is zero. For each of 100 replicates in a given genetic architecture, we computed p values for the two-tailed test of the null hypothesis that is zero. Averaging across all architectures, we observe that the false positive rate (the fraction of simulations for which the p value ) is 0.04 (Table S8). We additionally verified that the false positive rate in a large-scale simulation with different prevalences if one of the traits is binary and the situation where both traits are continuous. We observe that the false positive rate is not affected by the prevalence of binary trait (Table S8). Finally, we evaluated the accuracy of SCORE when applied to pairs of traits where one of the traits is binary while the other is continuous. We observe that the estimates of SCORE are unbiased across the range of prevalence of the binary trait (Table S9). Further, the estimates of obtained by SCORE tend to have relatively low SE provided the prevalence of the trait is greater than (Table S9) so that we recommend applying SCORE to traits whose prevalence is no less than .
Computational efficiency
We investigated the computational efficiency of SCORE relative to GCTA-GREML and GCTA-HE. The runtime and memory usage of summary statistic methods (LDSC and HDL) depend on the time needed to compute LD scores and summary statistics of each trait. In addition, HDL also requires the computation of the singular value decomposition (SVD) of LD matrices, which is a computationally expensive step. Thus, we do not include runtimes for LDSC and HDL in these comparisons. We varied the number of individuals, while the number of SNPs was fixed at . Figure 2 shows that GCTA-GREML and GCTA-HE could not scale beyond sample sizes greater than 100,000 because of the requirement of computing and operating on a GRM (we extrapolate the runtime of GCTA-GREML and GCTA-HE to be about 340 days and 44 days on the set of unrelated white British individuals in the UK Biobank). On the other hand, SCORE ran in about 1.5 h on the set of individuals by using partial overlap mode with random vectors, while the SCORE-OVERLAP variant ran in about 1 h on the same dataset.
Application of SCORE to UK Biobank
We applied SCORE to estimate for pairs of phenotypes in the UK Biobank across unrelated white British individuals and SNPs (material and methods). We compared the estimates obtained by LDSC versus SCORE for a subset of 28 traits in which LDSC produced valid estimates, i.e., traits for which none of the estimates were N/A (Figure 3). While the point estimates of from the two methods are highly concordant (Pearson correlation ), the SE of LDSC is about 1.57 times that of SCORE on average, which is equivalent to a 2.46-fold increase in sample size via SCORE (see Figures S5 and S6). In total, 192 pairs of traits were detected to have a significant non-zero by both SCORE and LDSC after Bonferroni correction for all pairs across the original set of 40 phenotypes . Consistent with its reduced SE, SCORE found 58 pairs with significant after Bonferroni correction that were not detected as significant by LDSC (; stars in Figure 3). We conclude that SCORE obtains improved power to identify statistically significant genetic correlations relative to LDSC.
We obtain concordant results when analyzing all pairs in our initial set of 40 traits. Although the point estimates of SCORE and LDSC are highly correlated (Pearson correlation ), the SE of LDSC is about 1.8 times that of SCORE on average, equivalent to a 3.24-fold increase in the sample size. In this setting, SCORE found 200 additional pairs of traits over LDSC (beyond the 245 pairs identified by both), while LDSC detected one pair as significant that SCORE did not detect as significant (Figure S7). To understand the impact of random vectors, we repeated our analysis with a different set of random vectors and observed that the Pearson correlation of estimates with the two sets is 0.999 (Figure S11).
We also analyzed all pairs in our initial set of 40 traits with HDL by using the set of SNPs for which reference eigenvectors are available.12 The SE of HDL is about 2.53 times that of SCORE on average, which is equivalent to a 6.4-fold increase in the sample size (HDL failed to converge for of the pairs where at least one of the traits is binary). Among these pairs, SCORE found 171 additional pairs of traits over HDL (beyond the 239 pairs identified by both), while HDL detected 14 pairs as significant that SCORE did not detect as significant. The summary of SE ratio of HDL and SCORE is shown in Figure S8.
To gain further insights into SCORE, we examined the SE of estimates for pairs of traits according to whether the traits were both binary, both quantitative, or had one member of the pair that was binary while the other was quantitative. The SE is largest when both traits are binary, intermediate when one of the traits is binary, and lowest when both traits are quantitative (average SE: 0.082, 0.035, and 0.02, respectively; Figure S9). We note that the SE increases when the prevalence of the binary trait decreases: the mean SE is 0.017 when the binary trait has prevalence , while the mean SE is 0.047 for pairs in which the binary trait has prevalence (Figure S10).
We also applied SCORE to imputed genotypes in unrelated white British individuals and SNPs (MAF ). SCORE required about 19 h to analyze a single pair of traits for imputed SNPs while requiring about 1.5 h on array SNPs (scaling linearly with the number of variants). Because SCORE uses a streaming approach that does not require all SNPs to be stored in memory, it is memory efficient, requiring about 2.3 GB to analyze imputed data. The estimates of are largely concordant across array and imputed SNPs (Pearson correlation of the point estimates with two sets of SNPs is 0.973). We found 423 trait pairs that have significant non-zero estimates (after Bonferroni correction) across both imputed and array genotypes, while 19 pairs are significant only in the analysis of imputed genotypes and 22 pairs are significant in the analysis of array genotypes (Figure S12).
To further illustrate its utility, we applied SCORE to estimate genetic correlation between coronary-artery-disease-related traits included in our set of 40 traits (angina and heart attack) and serum biomarkers (alanine [ALT] and aspartate aminotransferase [AST]). Serum liver enzyme levels, including ALT and AST, are markers of liver health and hepatic dysfunction, and they have been shown to be associated with cardiovascular disease,20, 21, 22 although the strength and consistency has varied among the studies.20 We observed significant positive between ALT/AST and the two coronary-artery-disease-related traits ( and for angina with ALT and AST, respectively; and for heart attack with ALT and AST, respectively). Our finding of significant positive suggests that hepatic dysfunction (higher serum levels of ALT and AST) and coronary artery disease have a shared genetic component.
Discussion
We have described SCORE, a scalable and accurate estimator of genetic correlation. We observe that the estimates of genetic correlation obtained by SCORE have accuracy comparable to GCTA-GREML13 while being scalable to biobank-scale data. SCORE can estimate the genetic correlation across pairs of traits when applied to common SNPs measured on unrelated white British individuals in the UK Biobank within a few h. In simulations, we showed that, compared to summary-statistic methods, SCORE obtains a reduction in the average standard error of relative to LDSC and relative to HDL, equivalent to a 3.24-fold and 1.56-fold increase in sample size. In application to 780 pairs of traits in the UK Biobank, SCORE discovered 200 pairs of traits with significant genetic correlation (after correcting for multiple testing) that were not discovered by LDSC. In application to 780 pairs, SCORE discovered 171 pairs of traits with significant genetic correlation (after correcting for multiple testing) that were not discovered by HDL, while HDL discovered 14 significant pairs not discovered by SCORE. It is plausible that the results of HDL might be altered by the computation of eigenvectors from the analyzed genotypes, although such an analysis can be computationally expensive
The statistical accuracy gain of SCORE relative to LDSC and HDL can be attributed to several factors. LDSC does not use all the available covariances among the summary statistics choosing to only model the variance. The LD information as summarized by the LD scores involve a number of approximations. Typically, LD scores are computed from an external reference panel. Even when in-sample LD is used (as we have here), computational considerations lead to the LD scores’ being computed from a subset of the samples and restricted to SNPs that fall within a fixed-length genomic window. While HDL models the covariance structure among the summary statistics, thereby utilizing additional information relative to LDSC, HDL relies on approximate computations of LD scores like LDSC. To enable computational efficiency, HDL also uses a truncated SVD of the LD score matrix that can potentially further reduce accuracy.
We discuss several limitations of SCORE. First, SCORE requires access to individual genotype and trait data. Summary-statistic methods such as LDSC and HDL have the advantage of being applicable in settings where access to individual-level data can be challenging. While summary-statistic methods also have the advantage of being relatively efficient, it is important to keep in mind that the summary statistics are dependent on specific choices of marker sets and covariates. Applying these methods to different sets of covariates and marker sets requires regenerating the summary statistics (and auxiliary information such as LD score matrices). Second, the model underlying SCORE assumes a quantitative trait. We have shown empirically that SCORE provides accurate estimates of genetic correlation when applied to binary traits provided the traits are not too rare (prevalence ). It would be of interest to extend SCORE to the setting of binary traits along the lines of the PCGC method.11 Finally, while SCORE estimates genome-wide genetic correlation, efficient methods that can partition genetic correlation across genomic annotations can provide additional insights into the shared genetic basis of traits.
Acknowledgments
This research was conducted with the UK Biobank resource under applications 33127 and 33297. We thank the participants of UK Biobank for making this work possible. This work was funded, in part, by NIH grants R35GM125055 (S.S.), P01HL28481 (P.P.), and U01DK105561 (P.P.), an Alfred P. Sloan Research Fellowship (S.S.), and NSF grant III-1705121 (Y.W. and S.S). B.P. and K.S.B. were partially supported by NIH awards R01 HG009120, R01 MH115676, R01 CA251555, R01 AI153827, R01 HG006399, R01 CA244670, and U01 HG011715.
Declaration of interests
The authors declare no competing interests.
Published: December 2, 2021
Footnotes
Supplemental information can be found online at https://doi.org/10.1016/j.ajhg.2021.11.015.
Web resources
GCTA-GREML and GCTA-HE, https://yanglab.westlake.edu.cn/software/gcta/
HDL reference panel, https://github.com/zhenin/HDL/wiki/Reference-panels
HDL software, https://github.com/zhenin/HDL
LDSC software, https://github.com/bulik/ldsc/
PLINK1.9, https://www.cog-genomics.org/plink/2.0
SCORE software, https://github.com/sriramlab/SCORE
UK Biobank, https://www.ukbiobank.ac.uk/
Supplemental information
References
- 1.van Rheenen W., Peyrot W.J., Schork A.J., Lee S.H., Wray N.R. Genetic correlations of polygenic disease traits: from theory to practice. Nat. Rev. Genet. 2019;20:567–581. doi: 10.1038/s41576-019-0137-z. [DOI] [PubMed] [Google Scholar]
- 2.Lee S.H., Yang J., Goddard M.E., Visscher P.M., Wray N.R. Estimation of pleiotropy between complex diseases using single-nucleotide polymorphism-derived genomic relationships and restricted maximum likelihood. Bioinformatics. 2012;28:2540–2542. doi: 10.1093/bioinformatics/bts474. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 3.Chen G.-B. Estimating heritability of complex traits from genome-wide association studies using IBS-based Haseman-Elston regression. Front. Genet. 2014;5:107. doi: 10.3389/fgene.2014.00107. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 4.Loh P.R., Tucker G., Bulik-Sullivan B.K., Vilhjálmsson B.J., Finucane H.K., Salem R.M., Chasman D.I., Ridker P.M., Neale B.M., Berger B., et al. Efficient Bayesian mixed-model analysis increases association power in large cohorts. Nat. Genet. 2015;47:284–290. doi: 10.1038/ng.3190. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 5.Loh P.R., Bhatia G., Gusev A., Finucane H.K., Bulik-Sullivan B.K., Pollack S.J., de Candia T.R., Lee S.H., Wray N.R., Kendler K.S., et al. Contrasting genetic architectures of schizophrenia and other complex diseases using fast variance-components analysis. Nat. Genet. 2015;47:1385–1392. doi: 10.1038/ng.3431. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 6.Sudlow C., Gallacher J., Allen N., Beral V., Burton P., Danesh J., Downey P., Elliott P., Green J., Landray M., 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: 10.1371/journal.pmed.1001779. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 7.Bulik-Sullivan B., Finucane H.K., Anttila V., Gusev A., Day F.R., Loh P.R., Duncan L., Perry J.R., Patterson N., Robinson E.B., et al. An atlas of genetic correlations across human diseases and traits. Nat. Genet. 2015;47:1236–1241. doi: 10.1038/ng.3406. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 8.Shi H., Mancuso N., Spendlove S., Pasaniuc B. Local genetic correlation gives insights into the shared genetic architecture of complex traits. Am. J. Hum. Genet. 2017;101:737–751. doi: 10.1016/j.ajhg.2017.09.022. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 9.Lu Q., Li B., Ou D., Erlendsdottir M., Powles R.L., Jiang T., Hu Y., Chang D., Jin C., Dai W., et al. A powerful approach to estimating annotation-stratified genetic covariance via gwas summary statistics. Am. J. Hum. Genet. 2017;101:939–964. doi: 10.1016/j.ajhg.2017.11.001. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 10.Speed D., Balding D.J. SumHer better estimates the SNP heritability of complex traits from summary statistics. Nat. Genet. 2019;51:277–284. doi: 10.1038/s41588-018-0279-5. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 11.Weissbrod O., Flint J., Rosset S. Estimating snp-based heritability and genetic correlation in case-control studies directly and with summary statistics. Am. J. Hum. Genet. 2018;103:89–99. doi: 10.1016/j.ajhg.2018.06.002. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 12.Ning Z., Pawitan Y., Shen X. Nature Publishing Group; 2020. High-definition likelihood inference of genetic correlations across human complex traits. Technical report. [DOI] [PubMed] [Google Scholar]
- 13.Ni G., Moser G., Wray N.R., Lee S.H., Schizophrenia Working Group of the Psychiatric Genomics Consortium Estimation of genetic correlation via linkage disequilibrium score regression and genomic restricted maximum likelihood. Am. J. Hum. Genet. 2018;102:1185–1194. doi: 10.1016/j.ajhg.2018.03.021. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 14.Hou K., Burch K.S., Majumdar A., Shi H., Mancuso N., Wu Y., Sankararaman S., Pasaniuc B. Accurate estimation of snp-heritability from biobank-scale data irrespective of genetic architecture. Nat. Genet. 2019;51:1244–1251. doi: 10.1038/s41588-019-0465-0. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 15.Zhang Y., Cheng Y., Ye Y., Jiang W., Lu Q., Zhao H. Comparison of methods for estimating genetic correlation between complex traits using gwas summary statistics. Brief Bioinform. 2020;22:bbaa442. doi: 10.1093/bib/bbaa442. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 16.Hutchinson M.F. A stochastic estimator of the trace of the influence matrix for laplacian smoothing splines. Commun. Stat. Simul. Comput. 1989;18:1059–1076. [Google Scholar]
- 17.Liberty E., Zucker S.W. The mailman algorithm: A note on matrix–vector multiplication. Inf. Process. Lett. 2009;109:179–182. [Google Scholar]
- 18.Wu Y., Sankararaman S. A scalable estimator of SNP heritability for biobank-scale data. Bioinformatics. 2018;34:i187–i194. doi: 10.1093/bioinformatics/bty253. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 19.Pazokitoroudi A., Wu Y., Burch K.S., Hou K., Zhou A., Pasaniuc B., Sankararaman S. Efficient variance components analysis across millions of genomes. Nat. Commun. 2020;11:4020. doi: 10.1038/s41467-020-17576-9. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 20.Ghouri N., Preiss D., Sattar N. Liver enzymes, nonalcoholic fatty liver disease, and incident cardiovascular disease: a narrative review and clinical perspective of prospective data. Hepatology. 2010;52:1156–1161. doi: 10.1002/hep.23789. [DOI] [PubMed] [Google Scholar]
- 21.Gao M., Cheng Y., Zheng Y., Zhang W., Wang L., Qin L. Association of serum transaminases with short- and long-term outcomes in patients with ST-elevation myocardial infarction undergoing primary percutaneous coronary intervention. BMC Cardiovasc. Disord. 2017;17:43. doi: 10.1186/s12872-017-0485-6. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 22.Choi K.M., Han K., Park S., Chung H.S., Kim N.H., Yoo H.J., Seo J.A., Kim S.G., Kim N.H., Baik S.H., et al. Implication of liver enzymes on incident cardiovascular diseases and mortality: A nationwide population-based cohort study. Sci. Rep. 2018;8:3764. doi: 10.1038/s41598-018-19700-8. [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.