Skip to main content
Nature Communications logoLink to Nature Communications
. 2018 Oct 19;9:4361. doi: 10.1038/s41467-018-06805-x

Large-scale genome-wide enrichment analyses identify new trait-associated genes and pathways across 31 human phenotypes

Xiang Zhu 1,2,, Matthew Stephens 2,3,
PMCID: PMC6195536  PMID: 30341297

Abstract

Genome-wide association studies (GWAS) aim to identify genetic factors associated with phenotypes. Standard analyses test variants for associations individually. However, variant-level associations are hard to identify and can be difficult to interpret biologically. Enrichment analyses help address both problems by targeting sets of biologically related variants. Here we introduce a new model-based enrichment method that requires only GWAS summary statistics. Applying this method to interrogate 4,026 gene sets in 31 human phenotypes identifies many previously-unreported enrichments, including enrichments of endochondral ossification pathway for height, NFAT-dependent transcription pathway for rheumatoid arthritis, brain-related genes for coronary artery disease, and liver-related genes for Alzheimer’s disease. A key feature of our method is that inferred enrichments automatically help identify new trait-associated genes. For example, accounting for enrichment in lipid transport genes highlights association between MTTP and low-density lipoprotein levels, whereas conventional analyses of the same data found no significant variants near this gene.


In genome-wide association studies, variant-level associations are hard to identify and can be difficult to interpret biologically. Here, the authors develop a new model-based enrichment analysis method, and apply it to identify new associated genes, pathways and tissues across 31 human phenotypes.

Introduction

Genome-wide association studies (GWAS) have successfully identified many genetic variants—typically single-nucleotide polymorphisms (SNPs)—underlying a wide range of complex traits1,2. GWAS are typically analyzed using single-SNP association tests, which assess the marginal correlation between the genotypes of each SNP and the trait of interest. This approach can work well for identifying common variants with sufficiently-large effects. However, for complex traits, most variants have small effects, making them difficult to identify even with large sample sizes3. Further, because many associated variants are noncoding it can be difficult to identify the biological mechanisms by which they may act.

Enrichment analysis—also referred to as pathway4 or gene set5 analysis—can help tackle both these problems. Instead of analyzing one variant at a time, enrichment analysis assesses groups of related variants. The idea—borrowed from enrichment analysis of gene expression6—is to identify groups of biologically related variants that are enriched for associations with the trait: that is, they contain a higher fraction of associated variants than would be expected by chance. By pooling information across many genetic variants this approach has the potential to detect enrichments even when individual genetic variants fail to reach a stringent significance threshold4. And because the sets of variants to be analyzed are often defined based on existing biological knowledge, an observed enrichment automatically suggests potentially relevant biological processes or mechanisms.

Although the idea of enrichment analysis is simple, there are many ways to implement it in practice, each with its own advantages and disadvantages. Here we build on a previous approach7 that has several attractive features not shared by most methods. These features include: it accounts for linkage disequilibrium (LD) among associated SNPs; it assesses SNP sets for enrichment directly, without requiring intermediate steps like imposing a significance cut-off or assigning SNP-level associations to specific genes; and it can reassess (“prioritize”) variant-level associations in light of inferred enrichments to identify which genetic factors are driving the enrichment.

Despite these advantages, this approach has a major limitation: it requires individual-level genotypes and phenotypes, which are often difficult or impossible to obtain, especially for large GWAS meta analyses combining many studies. Our major contribution here is to overcome this limitation, and provide a new method that requires only GWAS summary statistics (plus LD estimates from a suitable reference panel). This allows the method to be applied on a scale that would be otherwise impractical. Here, we exploit this to perform enrichment analyses of 3913 biological pathways and 113 tissue-based gene sets for 31 human phenotypes. Our results identify many novel pathways and tissues relevant to these phenotypes, as well as some that have been previously identified. By prioritizing variants within the enriched pathways we identify several trait-associated genes that do not reach genome-wide significance in conventional analyses of the same data. The results highlighted here demonstrate the potential for these enrichment analyses to yield novel insights from existing GWAS summary data.

Results

Method overview

Figure 1 provides a schematic method overview. In brief, we combine an enrichment model7 with regression with summary statistics (RSS)8, a multiple regression likelihood for single-SNP association summary statistics, to create a model-based enrichment method for GWAS summary data. We refer to this enrichment method as RSS-E.

Fig. 1.

Fig. 1

Schematic overview of RSS-E, a model-based enrichment analysis method for GWAS summary statistics. RSS-E combines three types of public data: GWAS summary statistics (1.1), external LD estimates (1.2), and predefined SNP sets (1.3). GWAS summary statistics consist of a univariate effect size estimate (β^j) and corresponding standard error (ŝj) for each SNP, which are routinely generated in GWAS. External LD estimates are obtained from an external reference panel with ancestry matching the population of GWAS cohorts. SNP sets here are derive from gene sets based on biological pathways or sequencing data. We combine these three types of data by fitting a Bayesian multiple regression (2.1–2.2) under two models about the enrichment parameter (θ): the baseline model (2.3) that each SNP has equal chance of being associated with the trait (M0: θ = 0), and the enrichment model (2.4) that SNPs in the SNP set are more often associated with the trait (M1: θ > 0). To test enrichment, RSS-E computes a Bayes factor (BF) comparing these two models (3.1). RSS-E also automatically prioritizes loci within an enriched set by comparing the posterior distributions of genetic effects (β) under M0 and M1 (3.2). Here we summarize the posterior of β as P1, the posterior probability that at least one SNP in a locus is trait-associated. Differences between P1 estimated under M0 and M1 reflect the influence of enrichment on genetic associations, which can help identify new trait-associated genes (3.2)

Specifically RSS-E requires single-SNP effect estimates and their standard errors from GWAS, and LD estimates from an external reference panel with similar ancestry to the GWAS cohort. Then, for any given set of SNPs, RSS-E estimates an enrichment parameter, θ, which measures the extent to which SNPs in the set are more often associated with the phenotype. This enrichment parameter is on a log10 scale, so θ = 2 means that the rate at which associations occur inside the set is ~100 times higher than the rate of associations outside the set, whereas θ = 0 means that these rates are the same. When estimating θ RSS-E uses a multiple regression model8 to account for LD among SNPs. For example, RSS-E will (correctly) treat data from several SNPs that are in perfect LD as effectively a single observation, and not multiple independent observations. RSS-E ultimately summarizes the evidence for enrichment by a Bayes factor (BF) comparing the enrichment model (M1: θ > 0) against the baseline model (M0: θ = 0). RSS-E also provides posterior distributions of genetic effects (β) under M0 and M1, and uses them to prioritize variants within enriched sets.

Although enrichment analysis could be applied to any SNP set, here we focus on SNP sets derived from gene sets such as biological pathways. Specifically, for a given gene set, we define a corresponding SNP set as the set of SNPs within 100 kb of the transcribed region of any member gene; we refer to such SNPs as “inside” the gene set. If a gene set plays an important role in a trait then genetic associations may tend to occur more often near these genes than expected by chance; our method is designed to detect this signal.

To facilitate large-scale analyses, we designed an efficient, parallel algorithm implementing RSS-E. Our algorithm exploits variational inference9, banded matrix approximation10 and an expectation-maximization accelerator11. Software is available at https://github.com/stephenslab/rss.

Method comparison based on simulations

The novelty of RSS-E lies in its use of whole-genome association summary statistics to infer enrichments, and more importantly, its automatic prioritization of genes in light of inferred enrichments. We are not aware of any published method with similar features. However, there are methods that can learn either enrichments or gene-level associations from GWAS summary statistics, but not both. We compare RSS-E to them through simulations using real genotypes12.

To benchmark its enrichment component, we compared RSS-E with a suite of conventional pathway methods, Pascal13, and a polygenic approach, LD score regression (LDSC)14. We started with simulations without model mis-specification, where baseline and enrichment datasets were generated from corresponding models (M0 and M1). Figure 2a and Supplementary Figure 1 show the trade-off between false and true enrichment discoveries for each method. All methods are powerful when the true underlying genetic architecture is polygenic, whereas LDSC performs worse when the truth is sparse. In both polygenic and sparse scenarios RSS-E is the most powerful method.

Fig. 2.

Fig. 2

Comparison of RSS-E to other methods for identifying enrichments from GWAS summary statistics. We used real genotypes12 to simulate individual-level data under two genetic architectures (“sparse” and “polygenic”) with four baseline-enrichment patterns: a baseline and enrichment datasets followed baseline (M0) and enrichment (M1) models in RSS-E; b baseline datasets assumed that a random set of near-gene SNPs were enriched for genetic associations and enrichment datasets followed M1; c baseline datasets assumed that a random set of coding SNPs were enriched for genetic associations and enrichment datasets followed M1; d baseline datasets followed M0 and enrichment datasets assumed that trait-associated SNPs were both more frequent, and had larger effects, inside than outside the target gene set. We computed the corresponding single-SNP summary statistics, and, on these summary data, we compared RSS-E with Pascal13 and LDSC14 using their default setups. Pascal includes two gene scoring options: maximum-of-χ2 (-max) and sum-of-χ2 (-sum), and two pathway scoring options: χ2 approximation (-chi) and empirical sampling (-emp). For each simulated dataset, both Pascal and LDSC produced enrichment p values, whereas RSS-E produced an enrichment BF; these statistics were used to rank the significance of enrichments. Each panel displays the trade-off between false and true enrichment discoveries for all methods in 200 baseline and 200 enrichment datasets of a given simulation scenario, and also reports the corresponding areas under the curve (AUCs), where a higher value indicates better performance. Simulation details and additional results are provided in Supplementary Figures 14

Next, to assess its robustness to mis-specification, we performed three sets of simulations where either the baseline (M0) or enrichment (M1) model of RSS-E were mis-specified. Specifically, we considered scenarios where (i) baseline data contained enrichments of random near-gene SNPs (Fig. 2b, Supplementary Fig. 2); (ii) baseline data contained enrichments of random coding SNPs (Fig. 2c, Supplementary Fig. 3); and (iii) enrichment data contained enrichments of effect sizes (Fig. 2d, Supplementary Fig. 4). The results show that RSS-E is highly robust to model mis-specification, and still consistently outperforms Pascal and LDSC.

Recent analyses using LDSC focus on genotype–phenotype associations of HapMap Project Phase 3 (HapMap3) SNPs15, even though summary statistics of 1000 Genomes Project SNPs16 are often available. We used this “SNP subsetting” strategy in data analyses to reduce computation, since computational costs of RSS-E decrease as the number of SNPs analyzed decreases (Methods). However, when subsetting GWAS summary statistics to HapMap3 SNPs, RSS-E also subsets LD estimates to HapMap3 SNPs (Fig. 1), whereas LDSC still uses LD estimates of 1000 Genomes SNPs. To assess the impact of “SNP subsetting” on RSS-E, we simulated data using all 1000 Genome SNPs, applied the enrichment methods to summary statistics of HapMap3 SNPs only, and then compared HapMap3-based results with results of analyzing all 1000 Genome SNPs. As above, RSS-E is robust to “SNP subsetting” and more powerful than other methods (Supplementary Fig. 5).

Finally, to benchmark its prioritization component, we compared RSS-E with four gene-based association methods1720. Figure 3 and Supplementary Figures 6, 7 show the power of each method to identify gene-level associations. RSS-E substantially outperforms existing methods even in the absence of enrichments (Fig. 3a), especially in the polygenic scenario. This is because RSS-E exploits a multiple regression framework8 to learn the genetic architecture from data of all genes and assesses their effects jointly, whereas other methods implicitly assume a fixed, sparse architecture and only use data of a single gene to estimate its effect. When datasets contain enrichments (Fig. 3b), RSS-E further leverages them, which existing methods ignore, to improve power.

Fig. 3.

Fig. 3

Comparison of RSS-E to other methods for identifying gene-level associations from GWAS summary statistics. We used real genotypes12 to simulate individual-level data with and without enrichment in the target gene set (a “baseline”; b “enrichment”), each under two genetic architectures (“sparse” and “polygenic”), and then computed corresponding single-SNP summary statistics. On these summary data, we compared RSS-E with four other methods: SimpleM17, VEGAS18, GATES19, and COMBAT20. We applied VEGAS to the full set of SNPs (-sum), to a specified percentage of the most significant SNPs (−10% and −20%), and to the single most significant SNP (-max), within 100 kb of the transcribed region of each gene. All methods are available in the package COMBAT (Methods). For each simulated dataset, we defined a gene as “trait-associated” if at least one SNP within 100 kb of the transcribed region of this gene had nonzero effect. For each gene in each dataset, RSS-E produced the posterior probability that the gene was trait-associated. whereas the other methods produced association p values; these statistics were used to rank the significance of gene-level associations. Each panel displays the trade-off between false and true gene-level associations for all methods in 100 datasets of a given simulation scenario, and reports the corresponding AUCs. Simulation details and additional results are provided in Supplementary Figures 6, 7

In conclusion, RSS-E outperforms existing methods in both enrichment and prioritization analysis, and is robust to a wide range of model mis-specification. To further investigate its real-world benefit, we applied RSS-E to analyze 31 complex traits and 4026 gene sets.

Multiple regression on 1.1 million variants across 31 traits

The first step of our analysis is multiple regression of 1.1 million HapMap3 common SNPs for 31 traits, using GWAS summary statistics from 20,883 to 253,288 European ancestry individuals (Supplementary Table 1; Supplementary Fig. 8). This step essentially estimates, for each trait, a baseline model (M0) against which enrichment models (M1) can be compared. The fitted baseline model captures both the size and abundance (“polygenicity”) of the genetic effects on each trait, effectively providing a two-dimensional summary of the genetic architecture of each trait (Fig. 4a; Supplementary Fig. 9; Supplementary Table 2).

Fig. 4.

Fig. 4

Baseline and enrichment analyses of GWAS summary statistics for 31 complex traits. References of these data are provided in Supplementary Notes. a Summary of inferred effect size distributions of 31 traits. Results are from fitting the baseline model (M0) to GWAS summary statistics of 1.1 million common HapMap3 SNPs for each trait using variational inference (Methods). We summarize effect size distribution using two statistics: the estimated fraction of trait-associated SNPs (average posterior probability of a SNP being trait-associated; x-axis) and the standardized effect size of trait-associated SNPs (average posterior mean effect size of all SNPs, normalized by phenotypic standard deviation and fraction of trait-associated SNPs; y-axis). Each dot represents a trait, with horizontal and vertical point ranges indicating posterior mean and 95% credible interval. See Supplementary Notes for more details. Note that some intervals are too small to be visible due to log10 scales. See Supplementary Table 2 for numerical values of all intervals. b Pairwise sharing of 3913 pathway enrichments among 31 traits. For each pair of traits, we estimate the proportion of pathways that are enriched in both traits, among pathways enriched in at least one of the traits (Methods). Traits are clustered by hierarchical clustering as implemented in the package corrplot (Methods). Darker color and larger shape represent higher sharing. The sharing estimates are provided in Supplementary Table 3. ALS amyotrophic lateral sclerosis; DS depressive symptoms; LOAD late-onset Alzheimer’s disease; NEU neuroticism; SCZ schizophrenia; BMI body mass index; HEIGHT adult height; WHR waist-to-hip ratio; CD Crohn’s disease; IBD inflammatory bowel disease; RA rheumatoid arthritis; UC ulcerative colitis; ANM age at natural menopause; CAD coronary artery disease; FG fasting glucose; FI fasting insulin; GOUT gout; HDL high-density lipoprotein; HR heart rate; LDL low-density lipoprotein; MI myocardial infarction; T2D type 2 diabetes; TC total cholesterol; TG triglycerides; URATE serum urate; HB hemoglobin; MCH mean cell HB; MCHC MCH concentration; MCV mean cell volume; PCV packed cell volume; RBC red blood cell count

The results emphasize that genetic architecture varies considerably among phenotypes: estimates of both polygenicity and effect sizes vary by several orders of magnitude. Height and schizophrenia stand out as being particularly polygenic, showing approximately ten times as many estimated associated variants as any other phenotype. Along the other axis, fasting glucose, fasting insulin and hemoglobin show the highest estimates of effect sizes, with correspondingly lower estimates for the number of associated variants. Although not our main focus, these results highlight the potential for multiple regression models like ours to learn about effect size distributions and genetic architectures from GWAS summary statistics.

Fitting the baseline model also yields an estimate of effect size for each SNP. These can be used to identify trait-associated SNPs and loci. Reassuringly, these multiple-SNP results recapitulate many associations detected in single-SNP analyses of the same data (Supplementary Figs. 1012). For several traits, these results also identify additional associations (Supplementary Figs. 13, 14). These additional findings, while potentially interesting, may be difficult to validate and interpret. Enrichment analysis can help here: if the additional signals tend to be enriched in a plausible pathway, it may both increase confidence in the statistical results and provide some biological framework to interpret them.

Enrichment analyses of 3913 pathways across 31 traits

We next performed enrichment analyses of SNP sets derived from 3913 expert-curated pathways, ranging in size from 2 to 500 genes (Supplementary Figs. 15, 16). For each trait-pathway pair we computed a BF testing the enrichment model (M1), and estimated the enrichment parameter (θ).

Since these analyses involve large-scale computations that are subject to approximation error, we developed some sanity checks for confirming enrichments identified by RSS-E. Specifically these simple methods confirm that the z-scores for SNPs inside a putatively enriched pathway have a different distribution from those outside the pathway (with more z-scores away from 0)—using both a visual check and a likelihood ratio statistic (Supplementary Fig. 17). Of note, these methods cannot replace RSS-E in the present study. The visual check requires human input, and thus is not suitable for large-scale analyses like ours. The likelihood ratio does not account for LD, and is expected to be less powerful (Supplementary Fig. 18).

Since genic regions may be generally enriched for associations compared with nongenic regions, we confirmed that top-ranked pathways often showed stronger evidence for enrichment than did the set containing all genes (Supplementary Fig. 19). We also created “null” (nonenriched) SNP sets by randomly drawing near-gene SNPs, and performed enrichment analyses of these “null” sets on real GWAS summary data. Enrichment signals of these simulated genic sets are substantially weaker than the actual top-ranked sets (Supplementary Fig. 20). Further, to check whether observed enrichments could be driven by other functional annotations (e.g., coding), we computed the correlation between enrichment BFs and proportions of gene-set SNPs falling into each of 52 functional categories14. Among 1612 trait-category pairs, we did not observe any strong correlation (median 7.3 × 10−3; 95% interval [−0.08 to 0.21]; Supplementary Fig. 21). Together, these results suggest that observed enrichments are unlikely to be artifacts driven by model mis-specification.

For most traits our analyses identify many pathways with strong evidence for enrichment—for example, 20 traits have enrichment BFs ≥ 108 in more than 100 pathways per trait (Supplementary Fig. 22). Although the top enriched pathways for a given trait often substantially overlap (i.e., share many genes), several traits show enrichments with multiple nonoverlapping or minimally overlapping pathways (Supplementary Fig. 23). Table 1 gives examples of top enriched pathways, with full results available online (Methods).

Table 1.

Top enriched biological pathways in complex traits

Phenotype Top enriched pathway Database # of signals (genes) log10BF
Neurological traits
Depressive symptoms Eicosapentaenoate biosynthesis HumanCyc (PC) 2 (12) 36.9
Alzheimer’s disease Golgi associated vesicle biogenesis Reactome (PC) 3 (49) 83.7
Anthropometric traits
Adult height Endochondral ossification WikiPathways (BS) 57 (65) 68.9
Immune-related traits
Crohn’s disease Inflammatory bowel disease KEGG (BS) 24 (61) 25.6
Inflammatory bowel disease Inflammatory bowel disease KEGG (BS) 26 (61) 24.2
Rheumatoid arthritis NFAT-dependent transcriptiona PID (BS) 11 (45) 10.0
Ulcerative colitis Inflammatory bowel disease KEGG (BS) 16 (61) 11.8
Metabolic traits
Age at natural menopause IL-2Rβ in T-cell activation BioCarta 2 (37) 866.7
Coronary artery disease p75(NTR)-mediated signaling PID (BS) 4 (55) 16.0
Fasting glucose Hexose transport Reactome (BS) 4 (47) 1,898.4
Gout Osteoblast signaling WikiPathways (BS) 2 (13) 30.6
High-density lipoprotein Statin pathway WikiPathways (BS) 18 (30) 113.9
Low-density lipoprotein Chylomicron-mediated lipid transport Reactome (PC) 11 (17) 65.5
Myocardial infarction Glutathione synthesis and recycling Reactome (PC) 2 (11) 9.6
Total cholesterol Glucose transport Reactome (BS) 2 (41) 833.2
Triglycerides Targets of C-MYC activationb PID (BS) 3 (79) 604.9
Serum urate Transport of glucose and othersc Reactome (PC) 4 (95) 1,558.1
Hematopoietic traits
Hemoglobin (HB) RNA polymerase I transcription Reactome (BS) 27 (107) 2,641.3
Mean cell HB (MCH) Meiotic synapsis Reactome (PC) 21 (72) 2,334.3
MCH concentration SIRT1 negative regulation of rRNAd Reactome (PC) 3 (63) 700.8
Mean cell volume DNA methylation Reactome (PC) 28 (61) 2,077.3
Packed cell volume RNA polymerase I promoter opening Reactome (PC) 27 (59) 217.5
Red blood cell count GSL biosynthesis (neolacto series) KEGG (PC) 2 (21) 391.2

For each trait here we report the most enriched pathway (if any) that (i) has an enrichment Bayes factor (BF) greater than 108; (ii) has at least 10 and at most 200 member genes; (iii) has at least two member genes with enrichment P1 > 0.9 (denoted as “signals”); and (iv) passes the visual and likelihood ratio sanity checks (Supplementary Fig. 17). All BFs reported here are larger than corresponding BFs that SNPs within 100 kb of transcribed regions of all genes are enriched (Supplementary Fig. 19). The corresponding baseline and enrichment parameter estimates are provided in online results (Methods). P1 posterior probability that at least one SNP within 100 kb of the transcribed region of a given gene has nonzero effect on the target trait; CaN: calcineurin; NFAT: nuclear factor of activated T cells; IL-2Rβ: interleukin-2 receptor beta chain; p75(NTR): p75 neurotrophin receptor; SIRT1: Sirtuin 1; GSL: glycosphingolipid; PC: Pathway Commons63; BS: NCBI BioSystems64

a The full name of this pathway is “calcineurin-regulated NFAT-dependent transcription in lymphocytes”

b The full name of this pathway is “validated targets of C-MYC transcriptional activation”

c The full name of this pathway is “transport of glucose and other sugars, bile salts and organic acids, metal ions and amine compounds”

d The full name of this pathway is “SIRT1 negatively regulates ribosomal RNA expression”

Our results highlight many previously reported trait-pathway links. For example, Hedgehog pathway is enriched for associations with adult height (BF = 1.9 × 1040), consistent with both pathway function21 and previous GWAS22. Other examples include interleukin-23 mediated signaling pathway with inflammatory bowel disease (BF = 3.1 × 1023; ref. 23), T helper cell surface molecule pathway with rheumatoid arthritis (BF = 3.2 × 108; ref. 24), statin pathway with levels of high-density lipoprotein cholesterol (BF = 8.4 × 10113; ref. 25), and glucose transporter pathway with serum urate (BF = 1.2 × 101558; ref. 26).

The results also highlight several pathway enrichments that were not reported in corresponding GWAS publications. For example, the top pathway for rheumatoid arthritis is calcineurin-regulated nuclear factor of activated T cells (NFAT)-dependent transcription in lymphocytes (BF = 1.1 × 1010). This result adds to the considerable existing evidence linking NFAT-regulated transcription to immune function27 and bone pathology28. Other examples of novel pathway enrichments include endochondral ossification pathway with adult height (BF = 7.7 × 1068; ref. 29), p75 neurotrophin receptor-mediated signaling pathway with coronary artery disease (BF = 9.6 × 1015; ref. 30), and osteoblast signaling pathway with gout (BF = 3.8 × 1030; ref. 31).

Overlapping pathway enrichments among related traits

Some pathways show enrichment in multiple traits. To gain a global picture of shared pathway enrichments among traits we estimated the proportions of shared pathway enrichments for all pairs of traits (Fig. 4b; Supplementary Table 3). Clustering these pairwise sharing results highlights four main clusters of traits: immune-related diseases, blood lipids, heart disorders, and red blood cell phenotypes. Blood cholesterol shows strong pairwise sharing with serum urate (0.67), hemoglobin (0.66), and fasting glucose (0.53), which could be interpreted as a set of blood elements. Serum urate shows moderate to strong sharing with rheumatoid arthritis (0.19) and inflammatory bowel diseases (0.38–0.63), possibly due to the function of urate crystals in immune responses32. Further, Alzheimer’s disease shows moderate sharing with blood lipids (0.17–0.23), heart diseases (0.15–0.21), and inflammatory bowel diseases (0.10–0.13). This seems consistent with recent data linking Alzheimer’s disease to lipid metabolism33, vascular disorder34, and immune activation35. The biologically relevant clustering of shared pathway enrichments helps demonstrate the potential of large-scale GWAS data to highlight similarities among traits, complementing other approaches such as clustering of shared genetic effects36 and coheritability analyses37.

Novel trait-associated genes informed by enriched pathways

A key feature of RSS-E is that pathway enrichments, once identified, are automatically used to prioritize associations at variants near genes in the pathway. Specifically, RSS-E gives almost identical estimates of the background parameter (θ0) in both baseline and enrichment analyses (Supplementary Fig. 24), and yields a positive estimate of the enrichment parameter (θ) if the pathway is identified as enriched (Supplementary Fig. 25). The positive estimate of θ increases the prior probability of association for SNPs in the pathway, which in turn increases the posterior probability of association for these SNPs.

This ability to prioritize associations, which is not shared by most enrichment methods, has several important benefits. Most obviously, prioritization analyses can detect additional genetic associations that may otherwise be missed. Furthermore, prioritization facilitates the identification of genes influencing a phenotype in two ways. First, it helps identify genes that may explain individual variant associations, which is itself an important and challenging problem38. Second, prioritization helps identify genes that drive observed pathway enrichments. This can be useful to check whether a pathway enrichment may actually reflect signal from just a few key genes, and to understand enrichments of pathways with generic functions.

To illustrate, we performed prioritization analyses on the trait-pathway pairs showing strongest evidence for enrichment. Following previous Bayesian analyses7,39, here we evaluated genetic associations at the level of loci, rather than individual SNPs. Specifically, for each locus we compute P1, the posterior probability that at least one SNP in the locus is associated with the trait, under both the baseline and enrichment hypothesis. Differences in these two P1 estimates reflect the influence of enrichment on the locus (Fig. 1).

The results show that prioritization analysis typically increases the inferred number of genetic associations (Supplementary Fig. 26), and uncovers putative associations that were not previously reported in GWAS. For example, enrichment in chylomicron-mediated lipid transport pathway (BF = 3.4 × 1065; Fig. 5a) informs a strong association between gene MTTP and levels of low-density lipoprotein (LDL) cholesterol (baseline P1: 0.14; enrichment P1: 0.99; Fig. 5b). This gene is a strong candidate for harboring associations with LDL: MTTP encodes microsomal triglyceride transfer protein, which has been shown to involve in lipoprotein assembly; mutations in MTTP cause abetalipoproteinemia, a rare disease characterized by low levels of apolipoprotein B and LDL cholesterol; and MTTP is a potential pharmacological target for lowering LDL cholesterol levels40. However, no genome-wide significant SNPs near MTTP were reported in single-SNP analyses of either the same data41 (Fig. 5c), or more recent data42 with larger sample size (Fig. 5d).

Fig. 5.

Fig. 5

Enrichment of chylomicron-mediated lipid transport pathway informs a strong association between a member gene MTTP and levels of low-density lipoprotein (LDL) cholesterol. a Distribution of GWAS single-SNP z-scores from summary data published in 201041, stratified by gene set annotations. The solid green curve is estimated from z-scores of SNPs within 100 kb of the transcribed region of genes in the chylomicron-mediated lipid transport pathway (“inside”), and the dashed reddish purple curve is estimated from z-scores of remaining SNPs (“outside”). This panel serves as a visual sanity check to confirm the observed enrichment. b Estimated posterior probability (P1) that there is at least one associated SNP within 100 kb of the transcribed region of each pathway-member gene under the enrichment model (M1) versus estimated P1 under the baseline model (M0). These gene-level P1 estimates and corresponding SNP-level statistics are provided in Supplementary Table 4. Yellow asterisks denote genes that are less than 1 Mb away from a GWAS hit. Blue circles denote genes that are at least 1 Mb away from any GWAS hit. c Regional association plot for MTTP based on summary data published in 201041. d Regional association plot for MTTP based on summary data published in 201342

Prioritization analysis of the same pathway (chylomicron-mediated lipid transport) also yields several additional plausible associations (Fig. 5b; Supplementary Table 4). These include LIPC (baseline P1: 0.02; enrichment P1: 0.96) and LPL (baseline P1: 0.01; enrichment P1: 0.76). These genes play important roles in lipid metabolism and both reach genome-wide significance in single-SNP analyses of high-density lipoprotein cholesterol and triglycerides41 although not for LDL cholesterol (Supplementary Fig. 27); and a multiple-trait, single-SNP analysis43 of the same data also did not detect associations of these genes with LDL.

Several other examples of putatively novel associations that arise from our gene prioritization analyses are summarized in Table 2, with related literature reported in Supplementary Notes.

Table 2.

Select putative gene-level associations from prioritization analyses

Phenotype Pathway (# of genes, log10BF) Gene Baseline P1 Enrichment P1
Adult height Endochondral ossification (65, 68.9) HDAC4 0.98 1.00
PTH1R 0.94 1.00
FGFR1 0.67 0.97
MMP13 0.45 0.93
Inflammatory bowel disease Cytokine receptor interactiona (253, 21.3) TNFRSF14 0.98 1.00
FAS 0.82 0.99
IL6 0.27 0.87
Rheumatoid arthritis NFAT-dependent transcriptionb (45, 10.0) PTGS2 0.74 0.98
PPARG 0.28 0.98
Coronary artery disease p75(NTR)-mediated signaling (55, 16.0) FURIN 0.69 0.99
MMP3 0.43 0.97
High-density lipoprotein Lipid digestion and transportc (58, 89.8) CUBN 0.24 1.00
ABCG1 0.01 0.89

BF: enrichment Bayes factor; P1: posterior probability that at least one SNP within 100 kb of the transcribed region of a given gene has nonzero effect on the target trait. NFAT: nuclear factor of activated T cells; p75(NTR): p75 neurotrophin receptor

a The full name of this pathway is “cytokine-cytokine receptor interaction”

b The full name of this pathway is “calcineurin-regulated NFAT-dependent transcription in lymphocytes”

c The full name of this pathway is “lipid digestion, mobilization, and transport”

Enrichment analyses of 113 tissue-based gene sets

RSS-E is not restricted to pathways, and can be applied more generally. Here, we use it to assess enrichment among tissue-based gene sets that we define based on gene expression data. Specifically, we use RNA sequencing data from the Genotype-Tissue Expression project44 to define sets of the most “relevant” genes in each tissue, based on expression patterns across tissues. The idea is that enrichment of GWAS signals near genes that are most relevant to a particular tissue may suggest an important role for that tissue in the trait.

A challenge here is how to define “relevant” genes. For example, are the highest expressed genes in a tissue the most relevant, even if the genes is ubiquitously expressed45? Or is a gene that is moderately expressed in that tissue, but less expressed in all other tissues, more relevant? To address this we considered three complementary methods to define tissue-relevant genes (Methods). The first method (“highly expressed”, HE) uses the highest expressed genes in each tissue. The second method (“selectively expressed”, SE) uses a tissue-selectivity score46 designed to identify genes that are much more strongly expressed in that tissue than in other tissues. The third method (“distinctively expressed”, DE) clusters tissue samples and identifies genes that are most informative for distinguishing each cluster from others47. This last method yields a list of “relevant” genes for each cluster, but most clusters are primarily associated with one tissue, and so we use this to assign genes to tissues. These methods often yield minimally overlapped gene sets for the same tissue (median overlap proportion: 4%; Supplementary Fig. 28).

Despite the small number of tissue-based gene sets relative to the pathway analyses above, this analysis identifies many strong enrichments. The top enriched tissues vary considerably among traits (Table 3), highlighting the benefits of analyzing a wide range of tissues. In addition, traits vary in which strategy for defining gene sets (HE, SE, or DE) yields the strongest enrichment results. For example, HE genes in heart show strongest enrichment for heart rate; SE genes in liver show strongest enrichment for LDL. This highlights the benefits of considering different annotation strategies, and suggests that, unsurprisingly, there is no single answer to the question of which genes are most “relevant” to a tissue.

Table 3.

Top enriched tissue-based gene sets in complex traits

Phenotype Tissue (method) log10BF Select top driving genes (# of signals)
Alzheimer’s disease Adrenal gland (SE) 45.6 APOE, APOC1 (2)
Neuroticism Brain (SE) 26.3 LINGO1, KCNC2 (2)
Adult height Nerve tibial (DE) 25.2b PTCH1, SFRP4, FLNB (59)
Crohn’s disease Cluster 1a (DE) 15.4 SMAD3, ZMIZ1, NUPR1 (6)
Inflammatory bowel disease Cluster 1a (DE) 15.8 SMAD3, ZMIZ1, NUPR1 (10)
Ulcerative colitis Heart (HE) 7.0 PLA2G2A, TCAP, ALDOA (4)
Age at natural menopause Brain (DE) 1053.2 BRSK1, PPP1R1B, NPTXR (6)
Coronary artery disease Brain (DE) 8.5 PSRC1, ZEB2, PTPN11 (3)
Fasting glucose Pancreas (SE) 2396.8 G6PC2, PDX1, SLC30A8 (5)
Fasting insulin Testis (SE) 866.7 ABHD1, PRR30, C2orf16 (3)
Heart rate Heart (HE) 4.1 MYH6, PLN (5)
High-density lipoprotein Liver (HE) 20.2 APOA1, APOE, MT1G, FTH1 (10)
Low-density lipoprotein Liver (SE) 33.4 ABCG5, LPA, ANGPTL3, HP (13)
Total cholesterol Liver (DE) 56.0 APOA1, APOE, HP (9)
Triglycerides Liver (HE) 93.2 APOA1, APOE, FTH1 (7)
Serum urate Kidney (SE) 210.8b SLC17A1, SLC22A11, PDZK1 (7)
Hemoglobin (HB) Whole blood (DE) 2078.1 HIST1H1E, HIST1H1C (4)
Mean cell HB Whole blood (DE) 1363.0 NPRL3, FBXO7, UBXN6 (11)
Mean cell volume Whole blood (DE) 1019.6b UBXN6, RBM38, NPRL3 (11)
Packed cell volume Heart (HE) 945.4 RPL19, TCAP (2)
Red blood cell count Breast (SE) 141.7 OBP2B, STAC2 (2)

Each tissue-based gene set contains 100 transcribed genes used in the Genotype-Tissue Expression project. For each trait we report the most enriched tissue-based gene set (if any) that has a Bayes factor (BF) greater than 1000 and has more than two member genes with enrichment P1 > 0.9 (denoted as “signals”). All trait-tissue pairs reported above pass the sanity checks (Supplementary Fig. 17) The corresponding baseline and enrichment parameter estimates are provided in online results (Methods). P1: posterior probability that at least one SNP within 100 kb of the transcribed region of a given gene has nonzero effect on the target trait; HE: highly expressed; SE: selectively expressed; DE: distinctively expressed

a Multiple tissues show partial membership in “Cluster 1”, including ovary, thyroid, spleen, breast, and stomach47

b These three BFs are smaller than corresponding BFs that SNPs within 100 kb of transcribed regions of all genes are enriched (Supplementary Fig. 19)

For some traits, the top enriched results (Table 3) recapitulate previously known trait-tissue connections (e.g., lipids and liver, glucose and pancreas), supporting the potential for our approach to identify trait-relevant tissues. Further, many traits show enrichments in multiple tissues. For example, associations in coronary artery disease are strongly enriched in genes related to both heart (SE, BF = 6.6 × 107) and brain (DE, BF = 3.5 × 108). The multiple-tissue enrichments highlight the potential for our approach to also produce novel biological insights, which we illustrate through an in-depth analysis of late-onset Alzheimer’s disease (LOAD).

Tissue-based analysis of LOAD identified three tissues with very strong evidence for enrichment (BF > 1030): liver, brain and adrenal gland. Because of the well-known connection between gene APOE and LOAD48, and the fact that APOE is highly expressed in these three tissues (Supplementary Notes), we hypothesized that APOE and related genes might be driving these results. To assess this we reanalyzed these strongly enriched gene sets after removing the entire apolipoproteins (APO) gene family from them. Of three tissues, only liver remains (moderately) enriched after excluding APO genes (Fig. 6), suggesting a possible role for non-APO liver-related genes in the etiology of LOAD.

Fig. 6.

Fig. 6

Enrichment analyses of genes related to liver, brain and adrenal gland for Alzheimer’s disease. Shown are the tissue-based gene sets with the strongest enrichment signals for Alzheimer’s disease. Each gene set was analyzed twice: the left panel corresponds to the analysis based on the original gene set; the right panel corresponds to the analysis where SNPs within 100 kb of the transcribed region of any gene in Apolipoproteins (APO) family (Methods) were excluded from the original gene set. Dashed reddish purple lines in both panel denote the same Bayes factor threshold (1000) used in the tissue-based analysis of all 31 traits (Table 3). HE highly expressed; SE selectively expressed; DE distinctively expressed

To identify additional genes underlying the liver enrichment, we performed prioritization analysis for non-APO liver-related genes. This highlighted an association of LOAD with gene TTR (baseline P1: 0.64; enrichment P1: 1.00; Supplementary Notes). TTR encodes transthyretin, which has been shown to inhibit LOAD-related protein from forming harmful aggregation and toxicity49,50. Indeed, transthyretin is considered a biomarker for LOAD: patients show reduced transthyretin levels in plasma51 and cerebrospinal fluid52. Rare variants in TTR have recently been found to be associated with LOAD53,54. By integrating GWAS with expression data our analysis identifies association of LOAD with TTR based on common variants.

Discussion

We have presented RSS-E, a new method for simultaneous enrichment and prioritization analysis of GWAS summary data, and illustrated its potential to yield novel insights by extensive analyses involving 31 phenotypes and 4026 gene sets. We have space to highlight only select findings, and expect that researchers will find the full results (Methods) to contain further insights.

Enrichment tests, sometimes known as “competitive tests”, have several advantages over alternative approaches—sometimes known as “self-contained tests”—that simply test whether a SNP set contains at least one association4,5. For example, for complex polygenic traits any large pathway will likely contain at least one association, making self-contained tests unappealing. Enrichment tests are also more robust to confounding effects such as population stratification, because confounders that affect the whole genome will generally not create artifactual enrichments. Indeed, in this sense enrichment results can be more robust than single-SNP results. (Nonetheless, most summary data analyzed here were corrected for confounding; see Supplementary Table 5.)

Compared with other enrichment approaches, RSS-E has several particularly attractive features. First, unlike many methods (e.g., 4,55.) RSS-E uses data from genome-wide common variants, and not only those that pass some significance threshold. This increases the potential to identify subtle enrichments even in GWAS with few significant results. Second, RSS-E models enrichment directly as an increased rate of association of variants within a SNP set. This contrasts with alternative two-stage approaches (e.g., 13,56.) that first collapse SNP-level association statistics into gene-level statistics, and then assess enrichment at the gene level. Our direct modeling approach has important advantages, most obviously that it avoids the difficult and error-prone steps of assigning SNP associations to individual genes, and collapsing SNP-level associations into gene-level statistics. For example, simply assigning SNP associations to the nearest gene may highlight the “wrong” gene and miss the “correct” gene (e.g., 38). Although our analyses do involve assessing proximity of SNPs to genes in a gene set, they avoid uniquely assigning each SNP to a single gene, which is a subtle but important distinction.

Perhaps the most important feature of RSS-E is that enrichment leads naturally to prioritization that highlights which genes in an enriched pathways are most likely to be trait-associated. We know of only two published methods7,57 with similar features, but both require individual-level data and so could not perform the analyses presented here. With candidate loci prioritized by RSS-E, researchers can further use off-the-shelf fine-mapping methods58 to pinpoint associations to single causal variants.

Although previous studies have noted potential benefits of integrating gene expression with GWAS data, our enrichment analyses of expression-based gene sets are different from, and complementary to, this previous work. For example, many studies have used expression quantitative trait loci (eQTL) data to help inform GWAS results (e.g., 59,60). In contrast we bypass the issue of detecting (tissue-specific) eQTLs by focusing only on differences in gene expression levels among tissues. And, unlike methods that attempt to (indirectly) relate expression levels to phenotype (e.g.,61,62), our approach focuses firmly on genotype–phenotype associations. Nonetheless, as our results from different tissue-based annotations demonstrate, it can be extremely beneficial to consider multiple approaches, and we view these methods as complimentary rather than competing.

Like any method, RSS-E also has limitations that need to be considered when interpreting results. For example, annotating variants as being “inside” a gene set based on proximity to a relevant gene, while often effective, can occasionally give misleading results. We saw an example of this when our method identified an enrichment of SE genes in testis with both total cholesterol and triglycerides. Further prioritization analysis revealed that this enrichment was driven by a single gene, C2orf16 which is (a) uniquely expressed in testis, and (b) physically close (53 kb) to another gene, GCKR, that is strongly associated with lipid traits (Supplementary Fig. 29). This highlights the need for careful examination of results, and also the utility of our prioritization analyses. Generally we view enrichments that are driven by a single gene as less reliable and useful than enrichments driven by multiple genes; indeed, enrichments driven by a single gene seem better represented as a gene association than as a gene set enrichment.

Other limitations of RSS-E stem from its use of variational inference for Bayesian calculations. Although these methods are computationally convenient in large datasets, and often produce reliable results, they also have features to be aware of. One feature is that when multiple SNPs in strong LD are associated with a trait, variational approximations tend to select one of them and ignore the others9. This feature will not greatly affect enrichment inference provided that SNPs that are in strong LD tend to have the same annotation (because then it will not matter which SNP is selected). And this holds for the gene-based annotations in the present study. However, it would not hold for finer-scale annotations (e.g., appearance in a DNase peak), and so in that setting the use of the variational approximation may need more care. More generally the accuracy of the variational approximation can be difficult to assess, especially since the underlying coordinate ascent algorithm only guarantees convergence to a local optimum. This said, the main alternative for making Bayesian calculations, Markov chain Monte Carlo, can experience similar difficulties.

Finally, the present study examines a single annotation (i.e., gene set) at a time. Practical issues that can occur in single-annotation analyses (not only ours) include: (a) an enrichment signal in one pathway can be caused by overlap with another pathway that is genuinely involved in the phenotype; and (b) for some traits (e.g., height), genetic associations may be strongly enriched near all genes, which will cause many gene sets to appear enriched. Extending RSS-E to jointly analyze multiple annotations like14 could help address these issues. However, this extension would increase computation costs, and we view the development of more efficient multiple-annotation enrichment methods as an important direction for future work.

Methods

GWAS summary statistics and LD estimates

We analyze GWAS summary statistics of 31 traits, in particular, the estimated single-SNP effect and standard error for each SNP. Following14, we use the same set of HapMap3 SNPs15 for all 31 traits, even though some traits have summary statistics available on all 1000 Genomes SNPs16. We use this “SNP subsetting” strategy to reduce computation, since the computational complexity of RSS-E (per iteration) is linear with the total number of SNPs (Supplementary Notes).

Among the HapMap3 SNPs, we also exclude SNPs on sex chromosomes, SNPs with minor allele frequency less than 1%, SNPs in the major histocompatibility complex region, and SNPs measured on custom arrays (e.g., Metabochip and Immunochip) from analyses. The final set of analyzed variants consists of 1.1 million SNPs (Supplementary Table 1, Supplementary Fig. 8).

Since GWAS summary statistics used here were all generated from European ancestry cohorts, we use haplotypes of individuals with European ancestry from the 1000 Genomes Project, Phase 316 to estimate LD10.

SNP annotations

To create SNP-level annotations for a given gene set, we use a distance-based approach from previous enrichment analyses7,56. Specifically, we annotate each SNP as being “inside” a gene set if it is within 100 kb of the transcribed region of a gene in the gene set. The relatively broad region is chosen to capture signals from nearby regulatory variants, since many GWAS hits are noncoding.

Biological pathways

Biological pathway definitions are retrieved from nine databases (BioCarta, BioCyc, HumanCyc, KEGG, miRTarBase, PANTHER, PID, Reactome, WikiPathways) that are archived by four repositories: Pathway Commons (version 7)63, NCBI Biosystems64, PANTHER (version 3.3)65, and BioCarta (used in ref. 7). Gene definitions are based on Homo sapiens reference genome GRCh37. Both pathway and gene data were downloaded on August 24, 2015. Following7, we compile a list of 3913 pathways that contains 2–500 autosomal protein-coding genes for the present study. We summarize pathway and gene information in Supplementary Figures 15, 16.

Tissue-based gene sets derived from transcriptome

Complex traits are often affected by multiple tissues, and it is not obvious a priori what the most relevant tissues are for the trait. Hence, it is necessary to examine a comprehensive set of tissues. The breadth of tissues in genotype-tissue expression (GTEx) project44 provides such an opportunity.

Here, we use RNA sequencing data to create 113 tissue-based gene sets. Due to the complex nature of extracting tissue relevance from sequencing data, we consider three different methods to derive tissue-based gene sets.

The HE method ranks the mean reads per kilobase per million mapped reads (RPKM) of all genes based on data of a given tissue, and then selects the top 100 genes with the largest mean RPKM values to represent the target tissue. We downloaded HE gene lists of 44 tissues with sample sizes greater than 70 from the GTEx Portal on November 21, 2016.

The SE method computes a tissue-selectivity (TS) score46 in each tissue for each gene, and then uses the top 100 genes with the largest TS scores to represent the target tissue. We obtained SE gene lists of 49 tissues from authors of ref. 46 on February 13, 2017.

The DE method summarizes 53 tissues as 20 clusters using admixture models47, computes a cluster-distinctiveness (CD) score in each cluster for each gene, and then uses the top 100 genes with the largest CD scores to represent the target cluster. We obtained DE gene lists of 20 clusters from authors of ref. 47 on May 19, 2016.

Bayesian statistical models

Consider a GWAS with n unrelated individuals typed on p SNPs. For each SNP j, we denote its estimated single-SNP effect size and standard error as β^j and ŝj, respectively. To model {β^j,ŝj}, we use the RSS likelihood8:

β^~NS^R^S^-1β,S^R^S^ 1

where β^:=(β^1,,β^p) is a p × 1 vector, S^:=diag(s^) is a p × p diagonal matrix with diagonal elements being s^:=(ŝ1,,ŝp), R^ is a p × p LD matrix estimated from an external reference panel with ancestry matching the GWAS cohort, β: = (β1,…,βp)′ are the true effects of each SNP on phenotype, and N denotes normal distributions.

To model enrichment of genetic associations within a given gene set, we borrow the idea from refs. 7,39, to specify the following prior on β:

βj~πjN0,σβ2+(1-πj)δ0, 2
σβ2=hj=1pπjn-1ŝj-2-1, 3
πj=1+10-(θ0+ajθ)-1, 4

where δ0 denotes point mass at zero, θ0 reflects the background proportion of trait-associated SNPs, θ reflects the increase in probability, on the log10-odds scale, that a SNP inside the gene set has nonzero effect, h approximates the proportion of phenotypic variation explained by genotypes of all available SNPs, and aj indicates whether SNP j is inside the gene set. Following7, we place independent uniform grid priors on the hyper-parameters {θ0, θ, h}; see Supplementary Tables 6, 7. (If one had specific information about hyper-parameters in a given application then this could be incorporated here.)

Posterior computation

We combine the likelihood function (Eq. (1)) and prior distribution (Eqs. (2)–(4)) above to perform Bayesian inference. The posterior computation procedures largely follow those developed in ref. 9. First, for each set of hyper-parameters {θ0, θ, h} from a predefined grid, we approximate the (conditional) posterior of β using a variational Bayes algorithm. Next, we approximate the posterior of {θ0, θ, h} by a discrete distribution on the predefined grid, using the variational lower bounds from the first step to compute the discrete probabilities. Finally, we integrate out the conditional posterior of β over the posterior of {θ0, θ, h} to obtain the full posterior of β.

Following7, we set random initialization as a default for the variational Bayes algorithm. Specifically, we randomly select an initialization, and then use this same initial value for all variational approximations over the grid of {θ0, θ, h}. This simple approach was used in all simulations and data analyses for the present study, and yielded satisfying results in most cases.

To facilitate large-scale analyses, we employ several computational tricks. First, we use squared iterative methods11 to accelerate the fixed point iterations in the variational approximation. Second, we exploit the banded LD matrix10 to parallelize the algorithm. Third, we use a simplification in ref. 7 that scales the enrichment analysis to thousands of gene sets by reusing expensive genome-wide calculations. See Supplementary Notes for details.

For one trait, the total computational cost of our analyses is determined by the number of whole-genome SNPs, the number of gene sets and the grid size for hyper-parameters, all of which can vary considerably among studies. It is thus hard to make general statements about computational time. However, to give a specific example, we finished baseline and enrichment analyses of 1.1 million HapMap3 SNPs and 3913 pathways for LDL within 36 h in a standard computer cluster (48 nodes, 12–16 CPUs per node).

All computations in the present study were performed on a Linux system with multiple (4–22) Intel E5–2670 2.6 GHz, Intel E5–2680 2.4 GHz or AMD Opteron 6386 SE processors.

Assess gene set enrichment

To assess whether a gene set is enriched for genetic associations with a target trait, we evaluate a Bayes factor (BF):

BF:=p(β^S^,R^,a,θ>0)p(β^S^,R^,a,θ=0), 5

where p(⋅) denotes probability densities, a: = (a1,…,ap)′ and aj indicates whether SNP j is inside the gene set. The observed data are BF times more likely under the enrichment model (M1: θ > 0) than under the baseline model (M0: θ = 0), and so the larger the BF, the stronger evidence for gene set enrichment. See Supplementary Notes for details of computing enrichment BF.

Detect association between a locus and a trait

To identify trait-associated loci, we consider two statistics derived from the posterior distribution of β. The first statistic is P1, the posterior probability that at least one SNP in the locus is associated with the trait:

P1:=1-Prβj=0,SNPjlocusD, 6

where D is a shorthand for the input data of RSS-E including GWAS summary statistics β^,S^, LD estimates R^ and SNP annotations (a, if any). The second statistic is ENS, the posterior expected number of associated SNPs in the locus:

ENS:=jlocusPr(βj0D). 7

See Supplementary Notes for details of computing P1 and ENS.

Estimate pairwise sharing of pathway enrichments

To capture pairwise sharing of enrichments, we define π = (π00, π01, π10, π11)′:

πab:=Prz1j=a,z2j=b,a{0,1},b{0,1}, 8

where zij equals one if pathway j is enriched in trait i and zero otherwise. Assuming independence among pathways and phenotypes, we estimate π by

π^:=argmaxπjπ00+π01BF2j+π10BF1j+π11BF1jBF2j, 9

where BFij is the enrichment BF for trait i and pathway j. We solve this optimization problem using an expectation-maximization algorithm implemented in the package ashr66. The conditional probability that a pathway is enriched in a pair of traits given that it is enriched in at least one trait, as plotted in Fig. 4b, is estimated as π^11(1-π^00).

Connection with enrichment analysis of individual-level data

RSS-E has close connection with previous work7 developed for individual-level data. Under certain conditions8, we can show that these two methods are mathematically equivalent, in the sense that they have the same fix point iteration scheme and lower bound in variational approximations. See Supplementary Notes for proofs. In addition to their theoretical connections, we also compared two methods through simulations, and observed similar inferential results (Supplementary Fig. 30).

Code availability

The RSS-E software is publicly available at https://github.com/stephenslab/rss. Illustrations of using RSS-E are provided in https://stephenslab.github.io/rss/Example-5. The RSS-E software has been tested in the following versions of MATLAB for 64-bit Linux: 9.3.0.713579 (R2017b), 8.4.0.150421 (R2014b), 8.2.0.701 (R2013b) and version 8.1.0.604 (R2013a). Results of the present study were generated from version 8.4.0.150421 (R2014b).

This study also used the following software packages: Pascal (https://www2.unil.ch/cbg/index.php?title=Pascal), LDSC (version 1.0.0, https://github.com/bulik/ldsc), COMBAT (version 0.0.2, https://cran.r-project.org/web/packages/COMBAT), corrplot (version 0.84, https://cran.r-project.org/web/packages/corrplot), and ashr (version 2.0.5, https://cran.r-project.org/web/packages/ashr). Default setups of these packages were used.

Electronic supplementary material

Acknowledgments

This study is supported by the Grant GBMF # 4559 from the Gordon and Betty Moore Foundation and NIH Grant HG02585 to M.S. This study makes use of data generated by the Wellcome Trust Case Control Consortium. A full list of the investigators who contributed to the generation of the data is available from www.wtccc.org.uk. We thank all the GWAS consortia for making their summary statistics publicly available. A full list of acknowledgments is in Supplementary Notes. We thank the GTEx consortium for making their RNA sequencing data publicly available. We thank P. Carbonetto and X. He for helpful comments on a draft manuscript. We thank C.A. Anderson, J.R.B. Perry, R.J.F. Loos and M. den Hoed for answering questions related to summary data of specific phenotypes. We thank M.C. Turchin for downloading summary statistics of red blood cell phenotypes under accession number EGAS00000000132. We thank S. Xi and K.K. Dey for providing GTEx expression-based gene lists. This work was completed with resources provided by the University of Chicago Research Computing Center.

Author contributions

X.Z. and M.S. conceived the study. X.Z. and M.S. developed the methods. X.Z. designed the algorithms, implemented the software, and performed the analyses. X.Z. and M.S. wrote the manuscript.

Data availability

Analysis results and all 4026 gene sets for the present study are publicly available at 10.5281/zenodo.1412872. The 4026 gene sets consist of 3913 biological pathways retrieved from the following four repositories: Pathway Commons (version 7, http://www.pathwaycommons.org/archives/PC2/v7), NCBI Biosystems (ftp://ftp.ncbi.nih.gov/pub/biosystems), PANTHER (version 3.3, ftp://ftp.pantherdb.org/pathway), BioCarta (used in ref. 7), and 113 tissue-based gene sets derived from GTEx transcriptome data (https://www.gtexportal.org/home/). Links to download GWAS summary statistics of 31 human phenotypes are provided in Supplementary Notes. The list of HapMap3 SNPs is available at https://data.broadinstitute.org/alkesgroup/LDSCORE/w_hm3.snplist.bz2. The 1000 Genomes Phase 3 data are available at ftp://ftp.1000genomes.ebi.ac.uk/vol1/ftp/release/20130502. The Wellcome Trust Case Control Consortium data are available at the European Genome-phenome Archive (https://www.ebi.ac.uk/ega/). The APO gene family is available at https://www.genenames.org/cgi-bin/genefamilies/set/405.

Competing interests

The authors declare no competing interests.

Footnotes

Publisher's note: Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Contributor Information

Xiang Zhu, Email: xiangzhu@stanford.edu.

Matthew Stephens, Email: mstephens@uchicago.edu.

Electronic supplementary material

Supplementary Information accompanies this paper at 10.1038/s41467-018-06805-x.

References

  • 1.Visscher PM, et al. 10 years of GWAS discovery: biology, function, and translation. Am. J. Hum. Genet. 2017;101:5–22. doi: 10.1016/j.ajhg.2017.06.005. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 2.Price AL, Spencer CC, Donnelly P. Progress and promise in understanding the genetic basis of common diseases. Proc. R. Soc. B. 2015;282:20151684. doi: 10.1098/rspb.2015.1684. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 3.Sham PC, Purcell SM. Statistical power and significance testing in large-scale genetic studies. Nat. Rev. Genet. 2014;15:335–346. doi: 10.1038/nrg3706. [DOI] [PubMed] [Google Scholar]
  • 4.Wang K, Li M, Hakonarson H. Analysing biological pathways in genome-wide association studies. Nat. Rev. Genet. 2010;11:843–854. doi: 10.1038/nrg2884. [DOI] [PubMed] [Google Scholar]
  • 5.de Leeuw CA, Neale BM, Heskes T, Posthuma D. The statistical properties of gene-set analysis. Nat. Rev. Genet. 2016;17:353–364. doi: 10.1038/nrg.2016.29. [DOI] [PubMed] [Google Scholar]
  • 6.Subramanian A, et al. Gene set enrichment analysis: a knowledge-based approach for interpreting genome-wide expression profiles. Proc. Natl Acad. Sci. USA. 2005;102:15545–15550. doi: 10.1073/pnas.0506580102. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 7.Carbonetto P, Stephens M. Integrated enrichment analysis of variants and pathways in genome-wide association studies indicates central role for IL-2 signaling genes in type 1 diabetes, and cytokine signaling genes in Crohn’s disease. PLoS Genet. 2013;9:e1003770. doi: 10.1371/journal.pgen.1003770. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 8.Zhu X, Stephens M. Bayesian large-scale multiple regression with summary statistics from genome-wide association studies. Ann. Appl. Stat. 2017;11:1561–1592. doi: 10.1214/17-AOAS1046. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 9.Carbonetto P, Stephens M. Scalable variational inference for Bayesian variable selection in regression, and its accuracy in genetic association studies. Bayesian Anal. 2012;7:73–108. doi: 10.1214/12-BA703. [DOI] [Google Scholar]
  • 10.Wen X, Stephens M. Using linear predictors to impute allele frequencies from summary or pooled genotype data. Ann. Appl. Stat. 2010;4:1158–1182. doi: 10.1214/10-AOAS338. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 11.Varadhan R, Roland C. Simple and globally convergent methods for accelerating the convergence of any EM algorithm. Scand. Stat. Theory Appl. 2008;35:335–353. doi: 10.1111/j.1467-9469.2007.00585.x. [DOI] [Google Scholar]
  • 12.Wellcome Trust Case Control Consortium. Genome-wide association study of 14,000 cases of seven common diseases and 3000 shared controls. Nature447, 661–678 (2007). [DOI] [PMC free article] [PubMed]
  • 13.Lamparter D, Marbach D, Rueedi R, Kutalik Z, Bergmann S. Fast and rigorous computation of gene and pathway scores from SNP-based summary statistics. PLoS Comput. Biol. 2016;12:e1004714. doi: 10.1371/journal.pcbi.1004714. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 14.Finucane HK, et al. Partitioning heritability by functional annotation using genome-wide association summary statistics. Nat. Genet. 2015;47:1228–1235. doi: 10.1038/ng.3404. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 15.International HapMap 3 Consortium. Integrating common and rare genetic variation in diverse human populations. Nature467, 52–58 (2010). [DOI] [PMC free article] [PubMed]
  • 16.1000 Genomes Project Consortium. A global reference for human genetic variation. Nature. 2015;526:68–74. doi: 10.1038/nature15393. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 17.Gao X, Starmer J, Martin ER. A multiple testing correction method for genetic association studies using correlated single nucleotide polymorphisms. Genet. Epidemiol. 2008;32:361–369. doi: 10.1002/gepi.20310. [DOI] [PubMed] [Google Scholar]
  • 18.Liu JZ, et al. A versatile gene-based test for genome-wide association studies. Am. J. Hum. Genet. 2010;87:139–145. doi: 10.1016/j.ajhg.2010.06.009. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 19.Li MX, Gui HS, Kwan JS, Sham PC. GATES: a rapid and powerful gene-based association test using extended Simes procedure. Am. J. Hum. Genet. 2011;88:283–293. doi: 10.1016/j.ajhg.2011.01.019. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 20.Wang M, et al. COMBAT: a combined association test for genes using summary statistics. Genetics. 2017;207:883–891. doi: 10.1534/genetics.117.300257. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 21.Varjosalo M, Taipale J. Hedgehog: functions and mechanisms. Genes Dev. 2008;22:2454–2472. doi: 10.1101/gad.1693608. [DOI] [PubMed] [Google Scholar]
  • 22.Wood AR, et al. Defining the role of common variation in the genomic and biological architecture of adult human height. Nat. Genet. 2014;46:1173–1186. doi: 10.1038/ng.3097. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 23.Teng MW, et al. IL-12 and IL-23 cytokines: from discovery to targeted therapies for immune-mediated inflammatory diseases. Nat. Med. 2015;21:719–729. doi: 10.1038/nm.3895. [DOI] [PubMed] [Google Scholar]
  • 24.Okada Y, et al. Genetics of rheumatoid arthritis contributes to biology and drug discovery. Nature. 2014;506:376–381. doi: 10.1038/nature12873. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 25.Nicholls SJ, et al. Statins, high-density lipoprotein cholesterol, and regression of coronary atherosclerosis. J. Am. Med. Assoc. 2007;297:499–508. doi: 10.1001/jama.297.5.499. [DOI] [PubMed] [Google Scholar]
  • 26.Köttgen A, et al. Genome-wide association analyses identify 18 new loci associated with serum urate concentrations. Nat. Genet. 2013;45:145–154. doi: 10.1038/ng.2500. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 27.Macian F. NFAT proteins: key regulators of T-cell development and function. Nat. Rev. Immunol. 2005;5:472–484. doi: 10.1038/nri1632. [DOI] [PubMed] [Google Scholar]
  • 28.Sitara D, Aliprantis AO. Transcriptional regulation of bone and joint remodeling by NFAT. Immunol. Rev. 2010;233:286–300. doi: 10.1111/j.0105-2896.2009.00849.x. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 29.Mackie E, Ahmed Y, Tatarczuch L, Chen KS, Mirams M. Endochondral ossification: how cartilage is converted into bone in the developing skeleton. Int. J. Biochem. Cell Biol. 2008;40:46–62. doi: 10.1016/j.biocel.2007.06.009. [DOI] [PubMed] [Google Scholar]
  • 30.Elshaer SL, El-Remessy AB. Implication of the neurotrophin receptor p75NTR in vascular diseases: beyond the eye. Expert. Rev. Ophthalmol. 2017;12:149–158. doi: 10.1080/17469899.2017.1269602. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 31.McQueen FM, Chhana A, Dalbeth N. Mechanisms of joint damage in gout: evidence from cellular and imaging studies. Nat. Rev. Rheumatol. 2012;8:173–181. doi: 10.1038/nrrheum.2011.207. [DOI] [PubMed] [Google Scholar]
  • 32.Rock KL, Kataoka H, Lai JJ. Uric acid as a danger signal in gout and its comorbidities. Nat. Rev. Rheumatol. 2013;9:13. doi: 10.1038/nrrheum.2012.143. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 33.Di Paolo G, Kim TW. Linking lipids to Alzheimer’s disease: cholesterol and beyond. Nat. Rev. Neurosci. 2011;12:284–296. doi: 10.1038/nrn3012. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 34.Beeri MS, et al. Coronary artery disease is associated with Alzheimer disease neuropathology in APOE4 carriers. Neurology. 2006;66:1399–1404. doi: 10.1212/01.wnl.0000210447.19748.0b. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 35.Heppner FL, Ransohoff RM, Becher B. Immune attack: the role of inflammation in Alzheimer disease. Nat. Rev. Neurosci. 2015;16:358–372. doi: 10.1038/nrn3880. [DOI] [PubMed] [Google Scholar]
  • 36.Pickrell JK, et al. Detection and interpretation of shared genetic influences on 42 human traits. Nat. Genet. 2016;48:709–717. doi: 10.1038/ng.3570. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 37.Bulik-Sullivan 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]
  • 38.Smemo S, et al. Obesity-associated variants within FTO form long-range functional connections with IRX3. Nature. 2014;507:371–375. doi: 10.1038/nature13138. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 39.Guan Y, Stephens M. Bayesian variable selection regression for genome-wide association studies and other large-scale problems. Ann. Appl. Stat. 2011;5:1780–1815. doi: 10.1214/11-AOAS455. [DOI] [Google Scholar]
  • 40.Rader DJ, Kastelein JJ. Lomitapide and mipomersen: two first-in-class drugs for reducing low-density lipoprotein cholesterol in patients with homozygous familial hypercholesterolemia. Circulation. 2014;129:1022–1032. doi: 10.1161/CIRCULATIONAHA.113.001292. [DOI] [PubMed] [Google Scholar]
  • 41.Teslovich TM, et al. Biological, clinical and population relevance of 95 loci for blood lipids. Nature. 2010;466:707–713. doi: 10.1038/nature09270. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 42.Global Lipids Genetics Consortium.. Discovery and refinement of loci associated with lipids levels. Nat. Genet. 2013;45:1274–1283. doi: 10.1038/ng.2797. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 43.Stephens M. A unified framework for association analysis with multiple related phenotypes. PLoS ONE. 2013;8:e65245. doi: 10.1371/journal.pone.0065245. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 44.The GTEx Consortium.. The genotype-tissue expression (GTEx) pilot analysis: Multitissue gene regulation in humans. Science. 2015;348:648–660. doi: 10.1126/science.1262110. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 45.Boyle EA, Li YI, Pritchard JK. An expanded view of complex traits: from polygenic to omnigenic. Cell. 2017;169:1177–1186. doi: 10.1016/j.cell.2017.05.038. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 46.Yang, R. Y. et al. A systematic survey of human tissue-specific gene expression and splicing reveals new opportunities for therapeutic target identification and evaluation. Preprint at 10.1101/311563 (2018).
  • 47.Dey KK, Hsiao CJ, Stephens M. Visualizing the structure of RNA-seq expression data using grade of membership models. PLoS Genet. 2017;13:e1006599. doi: 10.1371/journal.pgen.1006599. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 48.Liu CC, Kanekiyo T, Xu H, Bu G. Apolipoprotein E and Alzheimer disease: risk, mechanisms and therapy. Nat. Rev. Neurol. 2013;9:106–118. doi: 10.1038/nrneurol.2012.263. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 49.Schwarzman AL, et al. Transthyretin sequesters amyloid beta protein and prevents amyloid formation. Proc. Natl Acad. Sci. USA. 1994;91:8368–8372. doi: 10.1073/pnas.91.18.8368. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 50.Buxbaum JN, et al. Transthyretin protects Alzheimer’s mice from the behavioral and biochemical effects of Aβ toxicity. Proc. Natl Acad. Sci. USA. 2008;105:2681–2686. doi: 10.1073/pnas.0712197105. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 51.Velayudhan L, et al. Plasma transthyretin as a candidate marker for Alzheimer’s disease. J. Alzheimers Dis. 2012;28:369–375. doi: 10.3233/JAD-2011-110611. [DOI] [PubMed] [Google Scholar]
  • 52.Hansson SF, et al. Reduced levels of amyloid-β-binding proteins in cerebrospinal fluid from Alzheimer’s disease patients. J. Alzheimers Dis. 2009;16:389–397. doi: 10.3233/JAD-2009-0966. [DOI] [PubMed] [Google Scholar]
  • 53.Sassi C, et al. Influence of coding variability in APP-Aβ metabolism genes in sporadic Alzheimer’s Disease. PLoS ONE. 2016;11:e0150079. doi: 10.1371/journal.pone.0150079. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 54.Xiang Qun, Bi Rui, Xu Min, Zhang Deng-Feng, Tan Liwen, Zhang Chen, Fang Yiru, Yao Yong-Gang. Rare Genetic Variants of the Transthyretin Gene Are Associated with Alzheimer’s Disease in Han Chinese. Molecular Neurobiology. 2016;54(7):5192–5200. doi: 10.1007/s12035-016-0065-2. [DOI] [PubMed] [Google Scholar]
  • 55.Pers TH, et al. Biological interpretation of genome-wide association studies using predicted gene functions. Nat. Commun. 2015;6:5890. doi: 10.1038/ncomms6890. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 56.Segrè AV, et al. Common inherited variation in mitochondrial genes is not enriched for associations with type 2 diabetes or related glycemic traits. PLoS Genet. 2010;6:e1001058. doi: 10.1371/journal.pgen.1001058. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 57.Evangelou M, Dudbridge F, Wernisch L. Two novel pathway analysis methods based on a hierarchical model. Bioinformatics. 2014;30:690–697. doi: 10.1093/bioinformatics/btt583. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 58.Schaid Daniel J., Chen Wenan, Larson Nicholas B. From genome-wide associations to candidate causal variants by statistical fine-mapping. Nature Reviews Genetics. 2018;19(8):491–504. doi: 10.1038/s41576-018-0016-z. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 59.Nicolae DL, et al. Trait-associated SNPs are more likely to be eQTLs: annotation to enhance discovery from GWAS. PLoS Genet. 2010;6:e1000888. doi: 10.1371/journal.pgen.1000888. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 60.He X, et al. Sherlock: detecting gene-disease associations by matching patterns of expression QTL and GWAS. Am. J. Hum. Genet. 2013;92:667–680. doi: 10.1016/j.ajhg.2013.03.022. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 61.Gamazon ER, et al. A gene-based association method for mapping traits using reference transcriptome data. Nat. Genet. 2015;47:1091–1098. doi: 10.1038/ng.3367. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 62.Gusev A, et al. Integrative approaches for large-scale transcriptome-wide association studies. Nat. Genet. 2016;48:245–252. doi: 10.1038/ng.3506. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 63.Cerami EG, et al. Pathway Commons, a web resource for biological pathway data. Nucleic Acids Res. 2011;39:D685–D690. doi: 10.1093/nar/gkq1039. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 64.Geer LY, et al. The NCBI BioSystems database. Nucleic Acids Res. 2010;38:D492–D496. doi: 10.1093/nar/gkp858. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 65.Mi, H. & Thomas, P. PANTHER pathway: an ontology-based pathway database coupled with data analysis tools. Methods Mol. Biol. 563, 123–140 (2009). [DOI] [PMC free article] [PubMed]
  • 66.Stephens M. False discovery rates: a new deal. Biostatistics. 2017;18:275–294. doi: 10.1093/biostatistics/kxw041. [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

Analysis results and all 4026 gene sets for the present study are publicly available at 10.5281/zenodo.1412872. The 4026 gene sets consist of 3913 biological pathways retrieved from the following four repositories: Pathway Commons (version 7, http://www.pathwaycommons.org/archives/PC2/v7), NCBI Biosystems (ftp://ftp.ncbi.nih.gov/pub/biosystems), PANTHER (version 3.3, ftp://ftp.pantherdb.org/pathway), BioCarta (used in ref. 7), and 113 tissue-based gene sets derived from GTEx transcriptome data (https://www.gtexportal.org/home/). Links to download GWAS summary statistics of 31 human phenotypes are provided in Supplementary Notes. The list of HapMap3 SNPs is available at https://data.broadinstitute.org/alkesgroup/LDSCORE/w_hm3.snplist.bz2. The 1000 Genomes Phase 3 data are available at ftp://ftp.1000genomes.ebi.ac.uk/vol1/ftp/release/20130502. The Wellcome Trust Case Control Consortium data are available at the European Genome-phenome Archive (https://www.ebi.ac.uk/ega/). The APO gene family is available at https://www.genenames.org/cgi-bin/genefamilies/set/405.


Articles from Nature Communications are provided here courtesy of Nature Publishing Group

RESOURCES