Skip to main content

METHODS article

Front. Genet., 15 May 2020
Sec. Statistical Genetics and Methodology
This article is part of the Research Topic Statistical Methods, Computing, and Resources for Genome-Wide Association Studies View all 13 articles

MetaPhat: Detecting and Decomposing Multivariate Associations From Univariate Genome-Wide Association Statistics

  • 1Institute for Molecular Medicine Finland FIMM, Helsinki Institute of Life Science HiLIFE, University of Helsinki, Helsinki, Finland
  • 2Public Health, University of Helsinki, Helsinki, Finland
  • 3Broad Institute, Massachusetts Institute of Technology, Harvard University, Cambridge, MA, United States
  • 4Department of Mathematics and Statistics, University of Helsinki, Helsinki, Finland

Background: Multivariate testing tools that integrate multiple genome-wide association studies (GWAS) have become important as the number of phenotypes gathered from study cohorts and biobanks has increased. While these tools have been shown to boost statistical power considerably over univariate tests, an important remaining challenge is to interpret which traits are driving the multivariate association and which traits are just passengers with minor contributions to the genotype-phenotypes association statistic.

Results: We introduce MetaPhat, a novel bioinformatics tool to conduct GWAS of multiple correlated traits using univariate GWAS results and to decompose multivariate associations into sets of central traits based on intuitive trace plots that visualize Bayesian Information Criterion (BIC) and P-value statistics of multivariate association models. We validate MetaPhat with Global Lipids Genetics Consortium GWAS results, and we apply MetaPhat to univariate GWAS results for 21 heritable and correlated polyunsaturated lipid species from 2,045 Finnish samples, detecting seven independent loci associated with a cluster of lipid species. In most cases, we are able to decompose these multivariate associations to only three to five central traits out of all 21 traits included in the analyses. We release MetaPhat as an open source tool written in Python with built-in support for multi-processing, quality control, clumping and intuitive visualizations using the R software.

Conclusion: MetaPhat efficiently decomposes associations between multivariate phenotypes and genetic variants into smaller sets of central traits and improves the interpretation and specificity of genome-phenome associations. MetaPhat is freely available under the MIT license at: https://sourceforge.net/projects/meta-pheno-association-tracer.

Introduction

Genome-wide association studies (GWAS) of common diseases and complex traits in large population cohorts have linked thousands of genetic variants to individual phenotypes. In emerging biobank studies as well as in some disease specific collections have focused on, for example, Type 2 diabetes (T2D) (Mahajan et al., 2018) or coronary artery disease (CAD) (Ripatti et al., 2016), multiple related quantitative traits are simultaneously available for genetic association studies. The statistical power in these discovery efforts can be boosted considerably by multivariate tests, which have become more practical through recent implementations that require only univariate summary statistics, such as MultiPhen (O’Reilly et al., 2012), TATES (van der Sluis et al., 2013), CONFIT (Gai and Eskin, 2018), MTAG (Turley et al., 2018), MTAR (Guo and Wu, 2019), and metaCCA (Cichonska et al., 2016). The merits of many of these methods are further discussed by Chung et al. (2019). Concretely, canonical correlation analysis (CCA) (Hotelling, 1936) is the direct extension of the correlation coefficient to identify linear associations between two sets of variables, and it has been successfully applied also to GWAS (Inouye et al., 2012). Moreover, metaCCA extended CCA to work directly from GWAS summary statistics (effect size estimates and standard errors) of related traits and studies. However, a remaining challenge is to interpret which traits are driving the multivariate association and which traits are just passengers contributing little to the association statistic. A successful identification of a subset of central traits for each associated variant can lead to new biological insights in studies of disease progression and heterogeneity. To address this important task, we have introduced MetaPhat (Meta-Phenotype Association Tracer), a novel method to efficiently and systematically:

1. identify and annotate significant variants via multivariate GWAS from univariate summary statistics using metaCCA;

2. perform decomposition by systematically tracing the traits of highest and lowest statistical importance to identify subsets of central traits at each associated variant;

3. plot the traces of trait decompositions and cluster the variants based on the ranking of the importance of traits.

Materials and Methods

Workflow

MetaPhat requires as input a set of related GWAS summary statistics from correlated traits. The program implements efficient multi-trait genome-wide association testing, identification of significant associations, and systematic tracing of trait subsets to identify the central traits that consist of a statistically optimal set of traits together with a set of driver traits. A workflow is shown in Figure 1. In steps one to three, genome-wide significant variants [P < 5e-8, the established genome-wide threshold in the field (Sherry et al., 2001; Pe’er et al., 2008)] were identified and were clumped into independent groups that are subsequently represented by the lead variant of each group (i.e., the variant with the smallest P-value). By default, two lead variants were defined as independent if their distance is higher than 1 million base pairs. At step four, we carried out the decompositions of multivariate association by starting from model with all K traits and removing one trait at a time until only one trait remains. We proceeded via two different strategies that we named the highest trace and the lowest trace. More specifically, starting from the model with all K traits, we tested all unique combinations of (K-1) traits to find the subset with the highest CCA statistic (lowest P-value) that we assigned to the highest trace and the subset with the lowest CCA statistic (highest P-value) that we assigned to the lowest trace. We continued both traces iteratively until only a single trait remained by always choosing the subset with the highest CCA statistic on the highest trace and the subset with the lowest CCA statistic on the lowest trace. Intuitively, at each step, the trait dropped on the highest trace was the trait that was best replaceable by the other traits in the model with respect to the genetic association considered. Analogously, at each step, the trait dropped on the lowest trace was the trait that was most irreplaceable by the other traits in the model with respect to the genetic association considered. Altogether, we evaluated K2 subsets out of all possible 2K subsets while building these two traces. Base pair distances, GWAS P-value thresholds, and other program parameters could be updated using command-line arguments.

FIGURE 1
www.frontiersin.org

Figure 1. MetaPhat workflow 1. GWAS results for K traits are accepted as input. 2. After quality control and filtering, a multivariate GWAS is performed on the full model with all K traits using metaCCA via efficient multi-processing and chunking to reduce computation time. 3. Lead SNPs are detected and sorted based on the leading canonical correlation/P-value and then clumped based on a user-specified window size. Custom variants can be added. 4. Decomposition of chosen variants is performed through highest and lowest traces to find an optimal subset with a minimum BIC and driver traits based on the established P-value threshold. 5. MetaPhat results include trace plots for P-values and BIC, univariate association statistics plots for all lead SNPs, cluster maps (shown in Figure 2), and a summary table listing central traits (union of drivers and optimal subset).

We used the two traces to identify central traits that are primarily responsible for the association with the variant as explained next.

Evaluating Models

We used two quantities to evaluate models: CCA P-values and Bayesian Information Criterion (BIC; Schwarz, 1978). P-values allowed us to compare each association to the established “genome-wide significance threshold” of 5e-8 (Pe’er et al., 2008). By using the lowest trace, we could identify those traits without which the multivariate P-value is no longer genome-wide significant by simply collecting the traits that have been removed from the full model when the P-value on the lowest trace is first time above 5e-8. We call these traits the driver traits since they drive the association in the sense that without them the association does not anymore reach genome-wide significance and hence would not have been reported as a discovery in a GWAS. This definition of driver traits is based on a fixed P-value threshold, which is an established practice in the field, but does not claim any statistical optimality properties in terms of model comparison. Hence, to more rigorously compare models with different dimensionalities, we used BIC, which approximates the negative marginal likelihood of the model and thus penalizes for the model dimension (Schwarz, 1978). A lower BIC value suggests a statistically better description of the data. A subset of traits with minimum BIC would thus be the model of choice. We defined the optimal subset as the subset with the lowest BIC among all subsets on the highest trace and all subsets on the inverted lowest trace. The inverted lowest trace aggregates the traits that have been dropped on the lowest trace, and, in particular, includes the set of the driver traits as one of its subsets. Subsequently, we defined the central traits as the union of traits from the drivers and optimal BIC subset. MetaPhat traces and terms are summarized in Table 1.

TABLE 1
www.frontiersin.org

Table 1. MetaPhat terminology.

Computing P-Values and BIC From GWAS Summary Statistics

metaCCA outputs the first canonical correlation r1 between the genetic variant x and the set of k traits y1,…,yk and computes the corresponding P-value (Clarke et al., 2011; Cichonska et al., 2016). In this case, the first canonical correlation r1 equals to the maximum correlation between the variant and any linear combination of the traits and hence is equal to the square root of the variance explained R2 from the linear regression of x on y1,…,yk. In general, the expression for BIC is

BIC = log ( n ) k - 2 log l k ^

where n is the sample size, k is the number of parameters (here traits), and loglk^ is the maximized log-likelihood. Next, we have shown how to use metaCCA output r1 to derive BIC from the maximized likelihood of the linear model written as a function of R2 = r12.

Consider a linear model between a (mean-centered) variant x and (mean-centered) traits y = (y1,…,yk)T.

x = y T β + ε = y 1 β 1 + + y k β k + ε , ε N ( 0 , σ 2 ) ,

where we do not include the intercept parameter as its maximum likelihood estimate (MLE) is zero after mean-centering. The log-likelihood function is

loglk ( β , σ 2 ) = - n 2 log ( 2 π ) - n 2 log ( σ 2 ) - ( x - y T β ) T ( x - y T β ) 2 σ 2 ,

and MLEs are

β = ( y T y ) - 1 y T x and σ 2 2 = 1 n ( ( x - y T β ) T ( x - y T β ) ) .

Thus, the log-likelihood at maximum is

log lk ^ = log lk ( β ^ , σ ^ 2 ) = - n 2 log ( 2 π ) - n 2 log ( σ 2 ^ )
- ( x - y T β ^ ) T ( x - y T β ^ ) σ 2 ^ - n 2 log ( 2 π ) - n 2 log ( σ 2 ^ ) - n 2
R 2 = x T x - ( x - y T β ^ ) T ( x - y T β ^ ) x T x = 1 - σ 2 ^ σ 0 2 ^ ,

that  is,

σ 2 ^ σ 0 2 ^ = 1 - R 2 where σ 0 2 ^ = var ( x ) .

Hence, the logarithm of the likelihood ratio between the MLE and the null model can be written as

log LR = log lk ^ - log lk ( 0 , σ 0 2 ^ ) = - n 2 log σ 2 ^ σ 0 2 ^ = 1 - n 2 log ( 1 - R 2 ) .

Hence, we have that, for an additive constant c=-2loglk(0,σ022),

BIC = k log ( n ) - 2 ( l o g l k ^ ) = k log ( n ) + n log ( 1 - R 2 ) + c ,

which is possible to compute directly from the metaCCA output for models with at least two traits up to an additive constant c. Since c does not depend on the model dimension, we can ignore it in the BIC calculation, when we are only interested in the differences in BIC between models.

Finally, for a single-trait model, R2 can be computed directly from the univariate GWAS summary statistics as

R 2 = 1 ( 1 + n / z 2 ) where z = GWAS effect standard error ,

which can be plugged in the BIC formula above to yield BIC for the single-trait model.

Implementation and Output

MetaPhat is written in Python (compatible for 2.7 and 3+) and requires R (3.4+) for plotting. The command-line based program has been tested on multiple operating systems and cloud images. Library requirements and command options are further described in Supplementary Table S1, and test data are accessible from the project page: https://sourceforge.net/projects/meta-pheno-association-tracer.

MetaPhat outputs tabular text files and several plots. A summary result file contains, for each chosen variant, the driver traits and the optimal subset with their P-value and BIC statistics. For each variant, trace plots using P-values and BIC are generated, showing the highest trace, the lowest trace and the inverted lowest trace. In addition, the univariate P-values and directions of effects for each trait are also plotted. The estimated phenotype correlation matrix, clustered heatmaps of trait importance for the chosen variants and a similarity between variants using trait rankings on the lowest trace are produced. Optionally, intermediate statistics during the decomposition can be plotted to get a more detailed view of the decomposition process.

Materials

Our lipidomics data set consisted of the univariate GWAS results of 21 correlated lipid species with polyunsaturated fatty acids that were reported to exhibit high heritability (Tabassum et al., 2019) and showed high correlation (Supplementary Figure S2). These results originated from 2,045 Finnish subjects with imputed genotypes available at ∼8.5 million SNPs. The arbitrarily assigned lipid species identifiers along with their class names and fatty acid chemical properties are listed in Table 2A. To further validate MetaPhat, we processed summary statistics from four basic lipids [high-density lipoprotein (HDL) cholesterol, low-density lipoprotein (LDL) cholesterol, triglycerides (TG), and total cholesterol (TC)] conducted by the Global Lipids Genetics Consortium (GLGC) (Willer et al., 2013; Zhu et al., 2018), and these are listed in Table 2B. With the GLGC data set our aim was to compare MetaPhat results with univariate results reported by GLGC for all variants reported to be significantly associated with two or more traits by GLGC.

TABLE 2
www.frontiersin.org

Table 2. Lipid traits used in MetaPhat analysis.

Results

Using the lipidomics data sets with GWAS summary statistics from the 21 polyunsaturated lipids, MetaPhat found seven independent lead variants after clumping the 415 variants exceeding the standard GWAS P-value threshold of 5e-8 within a window of 1 Mb. Table 3 lists these variants along with their gene annotation, multivariate P-value, and central traits. MetaPhat has strongly reduced the multivariate association for all seven variants into smaller and more specific groups of central traits.

TABLE 3
www.frontiersin.org

Table 3. MetaPhat results of the 7 lead variants from the multivariate analyses of the lipidomics data.

We considered in more detail rs7412, which is a missense variant in the APOE gene and is known for its effect on LDL, as reported, for example, in the GLGC analysis (Willer et al., 2013). With the lipidomics data, this variant would not have been identified from any of the 21 univariate GWAS as the smallest univariate P-value was 1.1e-4 (trait PCO23, Supplementary Figure S3.6). On contrary, the multivariate GWAS by MetaPhat clearly highlighted this variant associated with the multivariate lipidomics (P = 4.2e-13) and further determined that the association was driven by CE14 and PCO23 (P-value after excluding these driver traits is 1.8e-06). The BIC-optimal subset for this variant extended the drivers by one additional trait and included CE14, PC36, and PCO23, which form the central traits. The trace plots for rs7412 are shown in Figure 2A (P-values for defining driver traits) and Figure 2B (BIC for defining optimal subset).

FIGURE 2
www.frontiersin.org

Figure 2. MetaPhat results using multivariate lipidomics data. (A) Trace plot of rs7412 identifies CE14 and PCO23 as the driver traits. (B) CE14, PC36, and PCO23 form the optimal subset as defined by minimum BIC (highest negative BIC). (C) Trait importance map of each SNP is the rank on the lowest trace where the rankings are transformed to the range of 0 and 1 values, with darker blue shades representing the most important traits of the multivariate association. (D) SNP similarity based on the rank correlation on the lowest trace.

Variants rs66505542 near BUD13 and rs261290 near ALDH1A2 both have only one driver trait (PI9 for BUD13 and PE7 for ALDH1A2) and three or five central traits (Table 3). Earlier, the APOA1 variant rs964184 within 100 kb of rs66505542 has been reported to be associated with TG (lead trait, P = 7.0e-224), TC, HDL, and LDL in GLGC data and rs66505542 itself with several cell phenotypes (platelet count, red cell distribution width, sum of eosinophil and basophil counts) in the GWAS catalog, while rs261290 has been reported to be associated with HDL (lead trait, P = 1.0e-188), TC, and TG in GLGC data (mapped to LIPC gene) and with HDL in the GWAS catalog.

A very different picture emerges for rs174567 near FADS1/2 since its 18 central traits show its wide effects across the lipidomics traits studied here. Previously reported FADS1/2 associations are with all lipid traits (TG lead trait, P = 7.0e-38) in GLGC data and with metabolite measurements and gallstones in the GWAS catalog.

Trait importance map that clusters each variant based on the lowest trace is shown in Figure 2C and the similarity of the variants as measured by rank correlation of the traits on the lowest trace is shown in Figure 2D. The trace plots for the other six variants than rs7412 are shown in Supplementary Figure S1.

Validation and Global Lipids Genetics Consortium

We processed the Global Lipids Genetics Consortium (GLGC) GWAS study for four plasma lipids (HDL, LDL, TC, and TG, as listed in Table 2B). These correlated traits along with large sample sizes and available summary files are suitable for MetaPhat GWAS and decomposition. We focused on the 13 variants reported by GLGC to have associations with three or more lipid traits (Supplementary Tables S2 and S3 from Willer et al., 2013). In Table 4, we validated that at 12 out of the 13 variants the same associations are confirmed by MetaPhat’s central traits. The only discordance was at rs6831256 (DOK7) where we found TC and TG as central traits compared to previously reported univariate associations with TC, TG, and LDL. As TC and LDL are highly correlated, it is understandable that the smaller dimension of the set TC, TG, may in some analyses be preferred over the set that also includes LDL. In Supplementary Table S2, we further report high concordance between our central traits and GLGC variants found associated with two or more standard lipids.

TABLE 4
www.frontiersin.org

Table 4. MetaPhat detection of driver and optimal lipid sets for 13 variants reported to be associated with at least three lipids by GLGC (12).

Performance

For computing the test statistic, MetaPhat uses metaCCA that, for a single SNP, has previously been shown to reliably estimate the results of standard CCA applied to individual level data (canoncorr function in Matlab) (Cichonska et al., 2016). Additionally, we also empirically validated MetaPhat multivariate findings with GLGC results.

MetaPhat considerably cuts down the computational demands of comprehensive subset testing. With K traits, there are 2K-1 non-empty subsets that have quickly become infeasible to systematically assess, while MetaPhat only considers about K2 models. For example, in our example with K = 21 traits, the gain in performance is about 4,700-fold compared to the complete subset testing. To further increase performance and usability, we have implemented flexibility for multi-thread processing to enable high performance and memory efficiency. On a moderate Google cloud image (16 vCPUs, 8 GB), the complete MetaPhat workflow for our lipidomics analysis, containing 21 lipids and 8.5 million SNPs, was completed in less than 2.5 h (143 min). Using 10 processors and 9 gigabytes of memory, the GLGC job with the four basic lipids and 2.4 million imputed SNPs completed in 24 min. MetaPhat also allows decomposition and plotting of custom SNPs. For example, the custom analysis of the 13 GLGC variants associated with three or more traits, shown in Table 4, was run again on existing GLGC MetaPhat results, and decomposition and plotting took only 2 min. We note that the run time could be longer on shared servers but also substantially shorter using more powerful dedicated cloud images.

Discussion

It is expected that a particular genetic variant may affect only a subset of related biomarkers that are risk factors of complex disorders, such as T2D or coronary heart disease. We implemented MetaPhat to systematically decompose and visualize statistically significant multivariate genome-phenome associations into a smaller group of central traits, based only on univariate GWAS summary statistics. We are not aware of comparable software to MetaPhat that would automatically carry out multivariate GWAS and identify central traits for the associations from summary statistics. ASSET (Bhattacharjee et al., 2012) aims to find the best trait subsets within a pool of multiple studies and has been applied particularly for case-control studies. MTAG (Turley et al., 2018) can be applied to GWAS results of multiple related traits and overlapping samples, but its aim is to improve the accuracy of the univariate effect sizes by using the information from correlated traits rather than decomposing the multivariate association to individual traits.

In our results from an analysis of 21 lipidomics traits, we demonstrated that the APOE association (rs7412) benefited from multivariate testing (driven by CE14 and PCO23 traits), as the univariate P-value was insignificant (P > 1e-4) across all 21 GWAS traits (shown in Supplementary Figure S3.6), but multivariate P-value was low (P < 5e-13). This variant is known to have a strong effect on LDL, and Table 2 shows that CE14 has the highest correlation with LDL (0.464). The other two central traits of this variant, PCO23 and PC36, did not have any correlation to basic lipids larger than 0.20 in absolute magnitude.

Table 3 lists the multivariate results including which four of these seven variants were previously reported by GLGC as associated with at least one of the four basic lipids. The other three variants also have some nearby variants that have been reported in the GWAS catalog (Buniello et al., 2019). First, rs8736 in MBOAT7 has been previously reported to be associated with human blood metabolites (Shin et al., 2014) as well as alcohol related cirrhosis of the liver (Buch et al., 2015). Second, variants in the region of rs146327691, near the SLCO1A2 gene, have been previously reported for response to serum metabolites (Krumsiek et al., 2012) and, interestingly, also for response to statins (Ho et al., 2006; Carr et al., 2019). Lastly, variants in the region of rs188167837 have been previously identified to be associated with nasopharyngeal carcinoma (Su et al., 2013). Additionally, MetaPhat decomposed most variants to substantially smaller sets of central traits than the full set of 21 traits, which can provide new biological insight regarding the variants identified. On the other hand, the essential role of FADS2 gene region in regulating unsaturation in fatty acids was clearly reflected in MetaPhat results, as we observed as many as 18 central traits at the lead variant. Provided that the exact mechanistic roles of polyunsaturated lipids toward heart disease (Teslovich et al., 2010; Malovini et al., 2016; Pizzini et al., 2017) are under active investigation, our findings warrant further evaluation. We further confirmed good concordance (60/67, Supplementary Table S2) with MetaPhat central traits with respect to the earlier reported GLGC associations with two or more standard lipids, and excellent concordance (12/13) with the associations with three or more standard lipids.

MetaPhat optimal subsets are derived from the minimum BIC score representing the model that best describes the data when we account for both the model fit and the model dimension. Qualitatively BIC statistic is similar to the widely-used AIC (Akaike, 1973) statistic, but BIC quantitatively differs from AIC by favoring smaller dimensions, which also improves the interpretation of the optimal models. As intuitively expected, and as seen in Table 3, the driver traits tend to be members of the optimal set although they do not always agree, since the driver traits are defined by a GWAS-specific criterion of P-value threshold 5e-8, which does not need to coincide with the optimal subset chosen by a more statistically justified BIC criterion.

Our software implements flexible parameters for custom multi-thread chunking to enable high performance, genome-wide, multi-trait meta-analysis while integrating metaCCA for multivariate testing followed by systematic decomposition of traits. Thus, a limitation of MetaPhat is that it relies on metaCCA, but other multivariate GWAS algorithms could also be used provided that these methods can work with univariate GWAS results as inputs and produce suitable metrics that can be used to derive the model comparison statistics. With regard to false positives, we used the standard GWAS cutoff (P = 5e-8), as carried out only a single multivariate GWAS to pick the lead variants. This cutoff can be adjusted according to the preferences of the users. MetaPhat also optionally allows the running of metaCCA+ (Cichonska et al., 2016) shown to protect against false positives via shrinkage that adds robustness to the analysis.

Finally, we remind the reader that MetaPhat decompositions are sequential, dropping one trait at a time, and hence are not guaranteed to produce the globally optimal subset. Additionally, for highly correlated traits, such as LDL and total cholesterol, the choice of which one is dropped first may not be completely robust to small changes in data.

The ability of MetaPhat to identify and visualize central traits will also be valuable in supporting efforts and pipelines (Fatumo et al., 2019) comparing results between univariate and multivariate associations as well as in studies that aim to increase specificity of multi-trait associations. We also expect that the multi-phenotype clustering results of MetaPhat can assist researchers investigating disease subtypes.

Data Availability Statement

All datasets generated for this study are included in the article/Supplementary Material.

Author Contributions

MP, SR, and JL conceived the project. MP developed the theory. JL implemented and tested the method. RT assisted with the testing. JL and MP draft the manuscript. All authors provided critical feedbacks and important contributions to the final manuscript.

Funding

This work was supported by the Academy of Finland (Grant Nos. 288509, 312076, 319181, and 325999).

Conflict of Interest

The authors declare that the research was conducted in the absence of any commercial or financial relationships that could be construed as a potential conflict of interest.

Supplementary Material

The Supplementary Material for this article can be found online at: https://www.frontiersin.org/articles/10.3389/fgene.2020.00431/full#supplementary-material

References

Akaike, H. (1973). “Information theory and an extension of the maximum likelihood principle,” in Proceedings of the 2nd International Symposium on Information Theory, eds B. N. Petrov and F. Csáki (Budapest: Akadémiai Kiadó), 267–281.

Google Scholar

Bhattacharjee, S., Rajaraman, P., Jacobs, K. B., Wheeler, W. A., Melin, B. S., Hartge, P., et al. (2012). A subset- based approach improves power and interpretation for the combined analysis of genetic association studies of heterogeneous traits. Am. J. Hum. Genet. 90, 821–835. doi: 10.1016/j.ajhg.2012.03.015

PubMed Abstract | CrossRef Full Text | Google Scholar

Buch, S., Stickel, F., Trépo, E., Way, M., Herrmann, A., Nischalke, H. D., et al. (2015). A genome-wide association study confirms PNPLA3 and identifies TM6SF2 and MBOAT7 as risk loci for alcohol-related cirrhosis. Nat. Genet. 47, 1443–1448. doi: 10.1038/ng.3417

PubMed Abstract | CrossRef Full Text | Google Scholar

Buniello, A., MacArthur, J. A. L., Cerezo, M., Harris, L. W., Hayhurst, J., Malangone, C., et al. (2019). The NHGRI-EBI GWAS catalog of published genome-wide association studies, targeted arrays and summary statistics 2019. Nucleic Acids Res. 47, D1005–D1012. doi: 10.1093/nar/gky1120

PubMed Abstract | CrossRef Full Text | Google Scholar

Carr, D. F., Francis, B., Jorgensen, A., Zhang, E., Chinoy, H., Heckbert, S. R., et al. (2019). Genomewide association study of statin-induced myopathy in patients recruited using the UK clinical practice research datalink. Clin. Pharmacol. Ther. 106, 1353–1361. doi: 10.1002/cpt.1557

PubMed Abstract | CrossRef Full Text | Google Scholar

Chung, J., Jun, G. R., and Dupuis, J. (2019). Comparison of methods for multivariate gene-based association tests for complex diseases using common variants. Eur. J. Hum. Genet. 27, 811–823. doi: 10.1038/s41431-018-0327-8

PubMed Abstract | CrossRef Full Text | Google Scholar

Cichonska, A., Rousu, J., Marttinen, P., Kangas, A. J., Soininen, P., Lehtimäki, T., et al. (2016). metaCCA: summary statistics-based multivariate meta-analysis of genome-wide association studies using canonical correlation analysis. Bioinformatics 32, 1981–1989. doi: 10.1093/bioinformatics/btw052

PubMed Abstract | CrossRef Full Text | Google Scholar

Clarke, G. M., Anderson, C. A., Pettersson, F. H., Cardon, L. R., Morris, A. P., Zondervan, K. T., et al. (2011). Basic statistical analysis in genetic case-control studies. Nat. Protoc. 6, 121–133. doi: 10.1038/nprot.2010.182

PubMed Abstract | CrossRef Full Text | Google Scholar

Fatumo, S., Carstensen, T., Nashiru, O., Gurdasani, D., Sandhu, M., and Kaleebu, P. (2019). Complimentary methods for multivariate genome-wide association study identify new susceptibility genes for blood cell traits. Front. Genet. 10:334. doi: 10.3389/fgene.2019.00334

CrossRef Full Text | Google Scholar

Gai, L., and Eskin, E. (2018). Finding associated variants in genome-wide association studies on multiple traits. Bioinformatics 34, i467–i474. doi: 10.1093/bioinformatics/bty249

PubMed Abstract | CrossRef Full Text | Google Scholar

Guo, B., and Wu, B. (2019). Integrate multiple traits to detect novel trait–gene association using GWAS summary data with an adaptive test approach. Bioinformatics 35, 2251–2257. doi: 10.1093/bioinformatics/bty961

PubMed Abstract | CrossRef Full Text | Google Scholar

Ho, R. H., Tirona, R. G., Leake, B., and Glaeser, H. (2006). Drug and bile acid transporters in rosuvastatin hepatic uptake: function, expression, and pharmacogenetics. Gastroenterology 130, 1793–1806. doi: 10.1053/j.gastro.2006.02.034

PubMed Abstract | CrossRef Full Text | Google Scholar

Hotelling, H. (1936). Relations between two sets of variates. Biometrika 28, 321–377. doi: 10.1093/biomet/28.3-4.321

CrossRef Full Text | Google Scholar

Inouye, M., Ripatti, S., Kettunen, J., Leo-Pekka, L., Oksala, N., Laurila, P., et al. (2012). Novel loci for metabolic networks and multi-tissue expression studies reveal genes for atherosclerosis. PLoS Genet. 8:e1002907. doi: 10.1371/journal.pgen.1002907

PubMed Abstract | CrossRef Full Text | Google Scholar

Krumsiek, J., Suhre, K., Evans, A. M., Matthew, W., Robert, P. M., Michael, V., et al. (2012). Mining the unknown: a systems approach to metabolite identification combining genetic and metabolic information. PLoS Genet. 8:e1003005. doi: 10.1371/journal.pgen.1003005

PubMed Abstract | CrossRef Full Text | Google Scholar

Mahajan, A., Taliun, D., Thurner, M., Robertson, N. R., Torres, J. M., Rayner, N. W., et al. (2018). Fine-mapping type 2 diabetes loci to single-variant resolution using high-density imputation and islet-specific epigenome maps. Nat. Genet. 50, 1505–1513. doi: 10.1038/s41588-018-0241-6

PubMed Abstract | CrossRef Full Text | Google Scholar

Malovini, A., Bellazzi, R., Napolitano, C., and Guffanti, G. (2016). Multivariate methods for genetic variants selection and risk prediction in cardiovascular Diseases. Front. Cardiovasc. Med. 3:17. doi: 10.3389/fcvm.2016.00017

PubMed Abstract | CrossRef Full Text | Google Scholar

O’Reilly, P. F., Hoggart, C. J., Pomyen, Y., Federico, C. F., Paul, C., Marjo-Riitta, E., et al. (2012). MultiPhen: joint model of multiple phenotypes can increase discovery in GWAS. PLoS One 7:e34861. doi: 10.1371/journal.pone.0034861

PubMed Abstract | CrossRef Full Text | Google Scholar

Pe’er, I., Yelensky, R., Altshuler, D., and Daly, M. J. (2008). Estimation of the multiple testing burden for genomewide association studies of nearly all common variants. Genet. Epidemiol. 32, 381–385. doi: 10.1002/gepi.20303

PubMed Abstract | CrossRef Full Text | Google Scholar

Pizzini, A., Lunger, L., Demetz, E., Hilbe, R., Weiss, G., Ebenbichler, C., et al. (2017). The role of omega-3 fatty acids in reverse cholesterol transport: a review. Nutrients 9:1099. doi: 10.3390/nu9101099

PubMed Abstract | CrossRef Full Text | Google Scholar

Ripatti, P., Rämö, J. T., Söderlund, S., Surakka, I., Matikainen, N., Pirinen, M., et al. (2016). The contribution of GWAS loci in familial dyslipidemias. PLoS Genet. 12:e1006078. doi: 10.1371/journal.pgen.1006078

PubMed Abstract | CrossRef Full Text | Google Scholar

Schwarz, G. E. (1978). Estimating the dimension of a model. Ann. Statist. 6, 461–464. doi: 10.1214/aos/1176344136

CrossRef Full Text | Google Scholar

Sherry, S. T., Ward, M. H., Kholodov, M., Baker, J., Phan, L., Smigielski, E. M., et al. (2001). dbSNP: the NCBI database of genetic variation. Nucleic Acids Res. 29, 308–311. doi: 10.1093/nar/29.1.308

PubMed Abstract | CrossRef Full Text | Google Scholar

Shin, S. Y., Fauman, E. B., Petersen, A. K., Krumsiek, J., Santos, R., Huang, J., et al. (2014). An atlas of genetic influences on human blood metabolites. Nat. Genet. 46, 543–550. doi: 10.1038/ng.2982

PubMed Abstract | CrossRef Full Text | Google Scholar

Su, W. H., Yao, J., Shugart, Y., Chang, K. P., Tsang, N. M., Tse, K. P., et al. (2013). How genome-wide SNP-SNP interactions relate to nasopharyngeal carcinoma susceptibility. PLoS One 8:e83034. doi: 10.1371/journal.pone.0083034

PubMed Abstract | CrossRef Full Text | Google Scholar

Tabassum, R., Rämö, J. T., Ripatti, P., Jukka, T. K., Mitja, K., Karjalainen, J., et al. (2019). Genetic architecture of human plasma lipidome and its link to cardiovascular disease. Nat. Commun. 10:4329. doi: 10.1038/s41467-019-11954-8

PubMed Abstract | CrossRef Full Text | Google Scholar

Teslovich, T. M., Musunuru, K., Smith, A. V., Edmondson, A. C., Stylianou, I. M., Koseki, M., et al. (2010). Biological, clinical and population relevance of 95 loci for blood lipids. Nature 466, 707–713. doi: 10.1038/nature09270

PubMed Abstract | CrossRef Full Text | Google Scholar

Turley, P., Walters, R. K., Maghzian, O., Okbay, A., Lee, J. J., Fontana, M. A., et al. (2018). Multi-trait analysis of genome-wide association summary statistics using MTAG. Nat. Genet. 50, 229–237. doi: 10.1038/s41588-017-0009-4

PubMed Abstract | CrossRef Full Text | Google Scholar

van der Sluis, S., Posthuma, D., and Dolan, C. V. (2013). TATES: efficient multivariate genotype-phenotype analysis for genome-wide association studies. PLoS Genet. 9:e1003235. doi: 10.1371/journal.pgen.1003235

PubMed Abstract | CrossRef Full Text | Google Scholar

Willer, C. J., Schmidt, E. M., Sengupta, S., Peloso, G. M., Gustafsson, S., Kanoni, S., et al. (2013). Discovery and refinement of loci associated with lipid levels. Nat. Genet. 45, 1274–1283. doi: 10.1038/ng.2797

PubMed Abstract | CrossRef Full Text | Google Scholar

Zhu, Z., Anttila, V., Smoller, J. W., and Lee, P. H. (2018). Statistical power and utility of meta-analysis methods for cross-phenotype genome-wide association studies. PLoS One 13:e0193256. doi: 10.1371/journal.pone.0193256

PubMed Abstract | CrossRef Full Text | Google Scholar

Keywords: multivariate analysis, genotype phenotype correlation studies, feature selection, Bayesian information criteria, visualilzation, canonical correlation, multivariate GWAS, pheno- and genotypes

Citation: Lin J, Tabassum R, Ripatti S and Pirinen M (2020) MetaPhat: Detecting and Decomposing Multivariate Associations From Univariate Genome-Wide Association Statistics. Front. Genet. 11:431. doi: 10.3389/fgene.2020.00431

Received: 04 February 2020; Accepted: 07 April 2020;
Published: 15 May 2020.

Edited by:

Guolian Kang, St. Jude Children’s Research Hospital, United States

Reviewed by:

Jaeyoon Chung, Boston University, United States
Wenjian Bi, University of Michigan, United States

Copyright © 2020 Lin, Tabassum, Ripatti and Pirinen. This is an open-access article distributed under the terms of the Creative Commons Attribution License (CC BY). The use, distribution or reproduction in other forums is permitted, provided the original author(s) and the copyright owner(s) are credited and that the original publication in this journal is cited, in accordance with accepted academic practice. No use, distribution or reproduction is permitted which does not comply with these terms.

*Correspondence: Jake Lin, jake.lin@helsinki.fi; Matti Pirinen, matti.pirinen@helsinki.fi

Disclaimer: All claims expressed in this article are solely those of the authors and do not necessarily represent those of their affiliated organizations, or those of the publisher, the editors and the reviewers. Any product that may be evaluated in this article or claim that may be made by its manufacturer is not guaranteed or endorsed by the publisher.