Abstract
Motivation
There is widespread interest in identifying genetic variants that exhibit parent-of-origin effects (POEs) wherein the effect of an allele on phenotype expression depends on its parental origin. POEs can arise from different phenomena including genomic imprinting and have been documented for many complex traits. Traditional tests for POEs require family data to determine parental origins of transmitted alleles. As most genome-wide association studies (GWAS) sample unrelated individuals (where allelic parental origin is unknown), the study of POEs in such datasets requires sophisticated statistical methods that exploit genetic patterns we anticipate observing when POEs exist. We propose a method to improve discovery of POE variants in large-scale GWAS samples that leverages potential pleiotropy among multiple correlated traits often collected in such studies. Our method compares the phenotypic covariance matrix of heterozygotes to homozygotes based on a Robust Omnibus Test. We refer to our method as the Parent of Origin Inference using Robust Omnibus Test (POIROT) of multiple quantitative traits.
Results
Through simulation studies, we compared POIROT to a competing univariate variance-based method which considers separate analysis of each phenotype. We observed POIROT to be well-calibrated with improved power to detect POEs compared to univariate methods. POIROT is robust to non-normality of phenotypes and can adjust for population stratification and other confounders. Finally, we applied POIROT to GWAS data from the UK Biobank using BMI and two cholesterol phenotypes. We identified 338 genome-wide significant loci for follow-up investigation.
Availability and implementation
The code for this method is available at https://github.com/staylorhead/POIROT-POE.
1 Introduction
Most genome-wide association studies (GWAS) implicitly assume the magnitude and direction of effect of a genetic variant on expression of a phenotype is independent of whether the variant was maternally or paternally inherited. However, there exists a distinct class of genetic variants for which this assumption is violated. Such variants harbor a parent-of-origin effect (POE) wherein the effect of an allele on a trait depends on whether it was transmitted from the mother or the father (Lawson et al. 2013). A substantial proportion of the variation in complex traits is not explained by the additive effects of common single-nucleotide polymorphisms (SNPs) across the genome. POEs may represent an important contribution to this missing heritability (Guilmatre and Sharp 2012).
There are multiple cited biological mechanisms by which POEs can arise in mammals. These include maternal intrauterine environment effects and effects of the maternal mitochondrial genome. However, the most frequently considered mechanism is genomic imprinting (Rampersaud et al. 2008). This epigenetic phenomenon was formally discovered in the 1980s primarily through embryological experiments (Reik and Walter 2001). In imprinting, the maternal and paternal alleles undergo differential epigenetic modifications that leads to parent-of-origin-specific transcription of the gene copies. Many imprinted genes tend to be found in clusters across the genome. Regulation of the expression of these clustered genes is under control of an imprinting control region (ICR), the mechanisms of which are complex (Barlow 2011). These ICR are often characterized by repetitive sequences and located near imprinted genes. It is estimated that only ∼1% of mammalian genes are subject to imprinting. However, there has been growing evidence for the existence of POE variants for a wide range of hereditary traits (Peters 2014). Classic examples of POE-associated diseases include Prader–Willi syndrome and Angelman syndrome. These diseases result from imprinted genes at 15q11-15q13 when only maternal or paternal copies are expressed, respectively (Aypar et al. 2014). Considerable research has further suggested POEs originate for a wide spectrum of complex traits, including obesity-related phenotypes, type 2 diabetes, basal-cell carcinoma, attention-deficit/hyperactivity disorder, schizophrenia, and breast cancer (Giannoukakis et al. 1993; Temple et al. 1995; Huxtable et al. 2000; Polychronakos and Kukuvitis, 2002; Dong et al. 2005; Palmer et al. 2006; Rampersaud et al. 2008; Kong et al. 2009; Wang et al. 2012; Hoggart et al. 2014).
To detect variants demonstrating POEs, studies have historically required genotype data from related individuals to ascertain parental ancestry of the inherited alleles. In the case of available parent-offspring trio or other forms of familial genomes, there are well-established methods to detect POEs (Weinberg et al. 1998; Weinberg 1999; Sinsheimer et al. 2003; Cordell et al. 2004; Becker et al. 2006; Ainsworth et al. 2011; Howey and Cordell 2012; Zhou et al. 2012; Connolly and Heron 2015; Howey et al. 2015). These approaches often test for a mean difference in allele effect based on grouping offspring by parent-of-origin of the allele. These mean-based tests are intuitive and optimally powered given sample size. Yet, the requirement of trio or more general family data severely limits this sample size in practice. This, in consequence, limits genome-wide discovery of the modest genetic effects that we anticipate for complex human traits.
Rather than rely on family studies of limited sample size to detect POEs, researchers have recently transitioned to detecting the phenomenon in GWAS-scale cohorts. This practice requires innovative statistical methods to deal with missing parental ancestry information. For example, Kong et al. (2009) inferred parental origin of alleles when parental genotype data are not available by first phasing Icelandic probands. For each of the proband haplotypes, they searched a genealogy database for the closest typed maternal and paternal relatives carrying that haplotype (Kong et al. 2009). For each haplotype, they constructed a robust score comparing the meiotic distances between the proband and these two relatives to quantify the likelihood of maternal or paternal transmission and ultimately assign parental origin. While this approach solves the issue of small sample sizes, power is still impacted by the potential inaccuracy or uncertainty in haplotypic reconstruction.
More recently, Hoggart et al. (2014) described a novel statistical method for detecting POEs for a single quantitative trait using GWAS data of unrelated individuals. The authors illustrated that the existence of a POE results in increased phenotypic variance among heterozygotes compared to homozygotes. They tested for this variance inflation using a robust version of the Brown–Forsythe test. The method successfully identified previously undocumented POE associations of two SNPs with body mass index (BMI). This work has enabled POE analysis in population studies of biobank scale.
A sizable proportion of genes in the GWAS catalog are pleiotropic (Chesmore et al. 2018). These genes affect more than one biological process, in turn associating with multiple (correlated) phenotypes (He and Zhang 2006). Analyzing the joint effects of a gene on more than one trait can often result in a marked increase in power over univariate approaches (O’Reilly et al. 2012; Solovieff et al. 2013; Kocarnik and Fullerton 2014). Importantly, well-established POEs in humans are usually the result of embryonic silencing of one parental allele. As this silencing generally occurs early in development, its effects are likely to present in all or nearly all tissues expressing the gene. When differential silencing of this gene affects multiple tissues, this can yield POEs for several distinct phenotypes. Joint analysis of multiple traits can leverage this potential pleiotropy to improve power over univariate variance-based POE tests while simultaneously reducing multiple testing burden of multiple phenotypes.
Here, we expand on the concept initially suggested by Hoggart et al. to develop a test for POEs in genetic studies of unrelated individuals that considers multiple quantitative phenotypes. We show that a pleiotropic POE variant will not only induce differences in the variance of POE traits between heterozygotes and homozygotes, but also in their corresponding covariances. In our method, POIROT (Parent-of-Origin Inference using Robust Omnibus Test), we test for equality of phenotypic covariances matrices between heterozygous and homozygous groups. Specifically, we use the robust omnibus (R-Omnibus) test (O’Brien 1992) to accommodate highly skewed traits. We first provide background on the statistical construction of our test statistic using the R-Omnibus framework. Next, through simulations, we demonstrate that our proposed method properly controls type I error and achieves superior power compared to the univariate approach of Hoggart et al. We also introduce a post hoc test that can help distinguish variants with POE effects from variants demonstrating more general gene–gene/gene–environment effects (which also induce patterns of trait variance/covariance that differ by genotype). We apply our method to GWAS data of BMI, high-density lipoprotein (HDL) cholesterol, and low-density lipoprotein (LDL) cholesterol from the UK Biobank and identify 338 significant potential POE loci. We conclude with a discussion of our findings, limitations, and proposed research to extend this work.
2 Materials and methods
2.1 Phenotype model
Using the notation of Hoggart et al. (2014) consider one biallelic SNP with reference allele A and alternative allele B. Assume we have collected individuals who have the homozygous AA genotype, individuals who have the homozygous BB genotype, and individuals who are heterozygous. Further assume we have collected K > 1 continuous phenotypes on all subjects and that we have already adjusted these phenotypes for the effects of non-genetic confounders like principal components of ancestry.
We first model phenotypes in homozygous AA subjects. Let be the vector of phenotypes for the ith AA individual. We can represent using the following framework
(1) |
Within (1), is the vector of phenotype means in AA subjects and is the vector of error terms. We assume that and , where is the variance–covariance matrix of the vector of error terms.
We next model phenotypes in homozygous BB subjects. Let be the vector of phenotypes for the ith BB individual. Further, let and represent the effect of the maternally inherited and paternally inherited B allele, respectively, on the kth phenotype. If there is no association between this SNP and the kth phenotype, it follows that . If there is a marginal association between this SNP and the kth phenotype, but there is no POE present, then . With this notation defined, we can model as
(2) |
Here, is as defined previously for (1), is the vector of maternal effects of the B allele on each of the k phenotypes, and is the vector of corresponding paternal effects of the B allele. Each element of and is assumed to be a fixed effect. Just as for the AA subjects in (1), we assume that and .
Lastly, we consider heterozygous AB individuals who carry only one copy of the alternative allele B. Let be the vector of phenotypes for the ith heterozygote. We can model this vector as
(3) |
In (3), is an indicator random variable where if individual i received the B allele from the mother and if individual i received the B allele from the father. We assume Bernoulli (½), as we expect that half of heterozygotes will have maternally-derived B alleles. The maternal and paternal effect vectors are as defined as for the model of BB subjects. We also assume that and . In other words, the covariance matrix of the error terms is the same within all three genotype groups.
Based on the derivations above, we can calculate the phenotype covariance matrix for each genotype category. Based on Equations (1) and (2), it is straightforward to show that the phenotype covariance matrix of AA individuals () is the same as the analogous matrix for BB individuals. Therefore, we can define as the phenotypic covariance matrix for all homozygous subjects. For heterozygous AB subjects modeled in Equation (3), we can show that (assuming ) the phenotype covariance matrix for heterozygotes is . Defining , we can show that if and only if
(4) |
This observation motivates the use of a test of equality of two covariance matrices for detecting POEs in a population-based sample where we cannot explicitly observe . If a POE SNP exists for any phenotype k, then and . Thus, the kth diagonal element of will be larger than the corresponding element of . Furthermore, if the SNP has POEs on two phenotypes k and k’, then . The kk’ element of will also be different from the corresponding off-diagonal element of .
2.2 POIROT method to detect POE SNPs
We can test the null hypothesis that no POEs exist at a given SNP for any of the K phenotypes under study () by equivalently testing . In our proposed method POIROT, we test for equality of these phenotypic covariance matrices between homozygotes and heterozygotes using the robust omnibus (R-Omnibus) test of O’Brien (O’Brien 1992). POIROT uses R-Omnibus rather than the traditional Box’s M test (Box 1949) to test covariance differences since the latter is highly sensitive to deviations of phenotypes from multivariate normality. This can lead to a undesirable elevation in type I error rates (Tiku and Balakrishnan 1984).
To derive the R-Omnibus test, we first center the phenotypes by the median within each genotype group (AA, AB, BB). This step is necessary if a marginal association exists between the alternative allele and a given phenotype. In that event, the variance of original phenotype values among aggregate homozygous subjects (AA, BB) would be erroneously inflated. We next group these centered phenotypes by homozygote versus heterozygote status. Let be the kth centered phenotype of the ith heterozygote ( and be the kth phenotype of the jth homozygous (AA and BB combined) individual (). We then calculate the median of each phenotype k in heterozygotes and homozygotes separately. Let be the median of the kth phenotype in the heterozygotes. Correspondingly, let be the median of the kth phenotype in the + homozygotes. For heterozygotes and homozygotes separately, we then calculate for phenotypes k and k’:
(5) |
(6) |
(7) |
(8) |
In (7) and (8), we standardize the Z measures by dividing by the square root of their absolute values. We consider to be the vector of W values for the ith heterozygous subject, and is the corresponding vector of W values for the jth homozygous subject. We then perform a two-sample Hotelling’s T2 test (Hotelling 1931) comparing our two sets of sample means (. There are dependent variables being compared between heterozygotes and homozygotes as this corresponds to the number of upper-triangular elements in the phenotypic covariance matrix. We calculate the test statistic , where is the inverse of the pooled covariance matrix estimate. Under the null, our test statistic (Hotelling 1931). The test can also be viewed as a one-way multivariate analysis of variance test (MANOVA).
2.3 Post hoc test for interaction effects
As detailed above, POIROT tests for a variant demonstrating POE by comparing/contrasting trait variances and covariances by genotype. However, trait variances can also differ by genotype when a variant exhibits a gene–gene (GxG) or gene–environment (GxE) interaction effect (Paré et al. 2010). To increase confidence that a variant identified by POIROT demonstrates a POE rather than a more general interaction effect, we propose a post hoc test that can be utilized to differentiate the two phenomena. The test is motivated by the observation that, for a general interaction effect, the variance of a quantitative phenotype among BB homozygous individuals is different from that of AA homozygotes. This observation is in contrast to the variance pattern expected under a POE, in which the variability of each homozygous group is the same after phenotype centering. Thus, we can craft a post hoc test that assesses the null hypothesis of a POE (trait variance/covariances are the same between the two homozygous categories) versus the alternative of a general interaction effect (trait variance/covariances differ between the two homozygous categories). We create such a test by implementing the R-Omnibus framework as previously outlined in Section 2.2 but restricted to comparison of the two homozygous groups (AA, BB).
2.4. Simulation study
We conducted a variety of simulation studies to determine POIROT’s ability to detect POEs while maintaining proper rates of type I error. We considered K = 3, 6, or 10 phenotypes and n = 3000, 5000, or 10 000 unrelated individuals. To generate phenotypes for each round of simulation, we first randomly generate K intercepts from a standard normal distribution to form the vector . This corresponds to the mean vector of phenotypes among AA homozygotes. For simplicity, we assume the diagonal elements of the matrix , corresponding to the variances of the random error terms, are all equal to one. We assume the K phenotypes exhibit one of three possible levels of pairwise correlation (low, medium, or high). We assume the pairwise trait correlations are randomly drawn from a uniform distribution. To simulate phenotypes exhibiting “low” correlation, we assume this is a Uniform(0,0.3) distribution. For phenotypes of “medium” and “high” correlation, we assume a Uniform(0.3,0.5) and Uniform(0.5,0.7) distribution, respectively. These random draws are used to populate the off-diagonal elements of .
Once we have constructed , we then randomly generate n maternal and paternal genotypes for a given SNP by sampling twice from a Bernoulli [p = MAF (minor allele frequency)] distribution for each parent. To generate offspring genotypes, we sample from a Bernoulli (p = .5) distribution to determine which maternal allele and which paternal allele is transmitted. Thus, we can now assign all n offspring to one of four genotype groups: (i) AB with maternal reference/paternal alternative, (ii) AB with paternal reference/maternal alternative, (iii) AA, and (iv) BB. We then simulate the phenotypic error vector for all n unrelated offspring by drawing from a multivariate distribution with mean 0 and variance-covariance matrix . The respective fixed maternal and paternal effect vectors of the alternative allele () are constructed depending on the specific null or alternative scenario under consideration. We then add these vectors to the random error and intercept term in concordance with the genotype group of each individual, as described in Section 2.1.
For type I error rate simulations, as described above, we assume these phenotypes have pairwise-trait correlation of levels low, medium, or high. To reflect the scenario where there exist no POEs or marginal effects of the alternative allele at the locus for any phenotype, we assume that . We also considered a second null scenario wherein a marginal association exists for the variant that is not specific to the parent of origin, i.e. . However, we note that if the same seeds are used in simulating the data, this marginal fixed effect is effectively removed when centering phenotypes by genotype group. The resulting test statistics are equivalent to the first null scenario. We first consider the circumstance where the random error terms are drawn from a normal distribution, i.e. the error follows and assume a MAF of 0.25. For each of the 27 combinations of number of phenotypes, sample size, and pairwise-trait correlation, we conducted 50 000 null simulations. To evaluate the robustness of our method to highly skewed phenotypes, we then repeated these parameter settings with non-normal random error terms. In particular, we utilize the method of Vale and Maurelli to simulate multivariate non-normal error terms assuming a skewness of two and excess kurtosis of two for each phenotype (Vale and Maurelli 1983). An example distribution of such a phenotype is illustrated in Supplementary Fig. S1.
Next, we investigated the power of our test when POEs do in fact exist for a locus. We again considered K = 3, 6, or 10 normally distributed phenotypes. We assumed 1, 2, or 3 had parent-of-origin specific associations with the variant. When the number of affected phenotypes is greater than one, this corresponds to pleiotropy. For these scenarios, we assumed and = 0.5, 0.6, or 0.75 for each phenotype k harboring a POE. All other elements of the maternal effect vector are 0 for the phenotypes with no POE associations. We again considered low, medium, and high pairwise-trait correlations. We assumed a MAF of 0.25 and sample sizes of 5000, and 10 000. We applied our method to 5000 simulated datasets for each of the 162 settings and calculated power at significance level . We also evaluated the power of POIROT when a locus is pleiotropic for POEs, but the magnitude of varies by phenotype. For this power analysis, we again tested 3, 6, or 10 total normal phenotypes, of which 2 or 3 are harboring POEs. Since maternal effect sizes of 0.5–0.75 were considered for the scenarios described above, we tested , when two phenotypes have POEs. When three phenotypes have POEs, we tested power using 0.5, 0.6, and 0.75 as maternal effect sizes.
We also compared the performance of POIROT to the corresponding univariate test of Hoggart et al. (2014). For the univariate test, we first calculated power using standard Bonferroni correction. Power was calculated as the proportion of loci for which the minimum observed P-value across the K phenotypes tested was less than . Given that these phenotypes are correlated and therefore may not reflect K independent tests, this approach can be overly conservative. Thus, we implemented a second more liberal approach that estimates the true number of independent tests, , which corresponds to the minimum number of principal components (PCs) explaining 90% of the variation in our K phenotypes. We then calculated power of the univariate approach as the proportion of loci for which the minimum observed P-value was less than (Gao et al. 2008; Broadaway et al. 2016). We then repeated these parameter settings for assessing power of POIROT with non-normal phenotypes, as described for null simulations.
Finally, we performed several simulations to investigate the performance of our proposed post hoc test for distinguishing POEs from general interaction effects. Under the null hypothesis (i.e. there exist POEs but no interaction effects for any of the phenotypes considered), we looked at type I error of the R-Omnibus test comparing phenotypic covariances of the two homozygous groups. Similar to above, we considered a MAF of 0.25 and 3, 6, or 10 tested phenotypes, of which 1, 2, or 3 had POEs but no interaction effects. We considered sample sizes of 5000 and 10 000, maternal POE effect sizes {0.5, 0.6, 0.75}, and low/medium/high trait correlation. We also evaluated the power of this post hoc test to identify GxE effects when present. Simulation parameters were informed by prior work of Paré et al. (2010). We considered a single unmeasured covariate drawn from a standard normal distribution. Again, we considered 3, 6, or 10 total quantitative traits, of which three had a non-negligible covariate effect. Of these three phenotypes, 1, 2, or 3 had gene–covariate interaction effects. The covariate effect sizes ranged from 0.3 to 0.7. Among the phenotypes with gene–covariate interaction effects, we varied to the proportion of total variation of each phenotype explained by the interaction effects between 0.005 and 0.01. Again, we allowed traits to have varying pairwise correlation. We performed 5000 simulations for each of the 216 power settings outlined for the post hoc interaction test.
2.5 Application of POIROT to UK Biobank
To assess the utility of POIROT for detecting POEs on continuous phenotypes using published population-based GWAS data, we utilized genotype and phenotype data from the UK Biobank (UKB), a large-scale biomedical database housing data collected from approximately 500 000 individuals from the UK (see Acknowledgements). This study allows for widespread investigation of the genetic variation associated with hundreds of lifestyle and health factors. To identify potential POE variants, we obtained data on three quantitative phenotypes [BMI (kg/m2), HDL cholesterol (mmol/l), and LDL cholesterol (mmol/l)]. Relevant covariates included genotyping array, PCs, sex, age at recruitment, and smoking status (prefer not to answer, never, previous, current). Prior to analysis, we removed all individuals identified as outliers according to pre-calculated metrics of genotype missingness, heterozygosity, and excess relativeness. We excluded those with putative sex chromosome aneuploidy and those who were not included in PCA calculation. We included individuals of self-reported white British ancestry only.
Subjects were genotyped using either the UK BiLEVE or UK Biobank Axiom arrays. We considered only autosomal variants with MAF >0.05, Hardy–Weinberg equilibrium P > 1e−8, and missingness rate <0.02. After quality control and filtering, 330 801 SNPs remained for analysis across 292 779 unrelated individuals with complete phenotype and covariate information. There is moderate negative correlation between BMI and HDL cholesterol (Pearson’s r = −0.35), low positive correlation between BMI and LDL (r = 0.02), and low positive correlation between LDL and HDL (r = 0.10). However, all estimated correlations are statistically significant (P < 2.2e−16). Covariate adjustment was performed by first fitting a linear model for each phenotype and extracting the residuals as the new adjusted phenotypes. We then applied POIROT to these three adjusted phenotypes to jointly test for POEs across the genome. We compared the findings of our approach to those from the method of Hoggart et al. performed on each phenotype individually. For any variant identified by POIROT meeting the Bonferroni-adjusted genome-wide significance threshold, we applied our proposed post hoc test to assess if the effect might be explained by a general interaction effect rather than a POE.
We concluded with a follow-up analysis to determine whether we see enrichment of variants in imprinting regions among those with lowest POIROT P-values for detecting POEs in the UKB cohort. We first downloaded genes of known imprinting and predicted imprinting status in humans from the GeneImprint database (https://www.geneimprint.com/). We then determined which variants in the UKB dataset fell within 500 kb of the starting and ending site of these genes. We defined these as our variant set of interest [comparable to a gene set in Gene Set Enrichment Analysis (GSEA)]. We then utilized the GSEAPreranked tool to test for enrichment of variants in this set among those top ranked variants by -log10(POIROT P-value) (Mootha et al. 2003; Subramanian et al. 2005).
3 Results
3.1 Type I error rate
We summarize the type I error of null scenarios with a sample size of 5000 individuals using Quantile-Quantile (QQ) plots in Fig. 1 (normal traits) and Fig. 2 (non-normal traits). Across the settings considered, our method yields the expected distribution of P-values under the null hypothesis of no POEs for any single phenotype. The distribution of the P-values is again as expected under the null when we have non-normality of phenotypes (Fig. 2), suggesting our method remains robust. We summarize the empirical type I error rates of our proposed test and the competing univariate approach at significance level in Supplementary Table S1. POIROT maintained appropriate type I error across all scenarios for normally distributed traits. We observed slightly higher error when 6 or 10 highly-skewed non-normal phenotypes were tested. The univariate approach with correction for tests showed minor inflation with 6 or 10 highly correlated phenotypes.
3.2 Power
Simulation results comparing the performance of POIROT to the competing univariate test under the assumption of true POE(s) are summarized in Fig. 3. This figure reflects normally distributed traits and sample size of 5000 (). Corresponding results from all other additional power settings, including both normal and non-normal traits, sample sizes of 5000 and 10 000, and are provided in Supplementary Figs S2–S9.
Simple Bonferroni correction tends to be overly conservative in the presence of correlated traits. We therefore used two multiple-testing correction approaches for the univariate method. As power generally increases with increasing sample size and POE magnitude, the scenarios shown in Fig. 3 correspond to a of 0.75 and sample size of 5000. For almost all scenarios, we see three general trends. First, unlike the univariate method, our method successfully leverages the correlation among phenotypes. We see power increasing with increasing trait correlation. Second, when pleiotropy exists and more than one phenotype harbors a POE, our method outperforms the univariate approach regardless of the multiple testing correction strategy. Third, power of POIROT increases as the number of phenotypes associated with the maternally-transmitted alternative allele increases across all levels of phenotypic correlation. Under simulated pleiotropic POE loci with varying , the power of POIROT tends to reflect the power assuming a constant for POE phenotypes at the median effect size (Supplementary Figs S10 and S11).
The one exception to these trends is the top right panel of Fig. 3. This reflects the scenario where three of three phenotypes harbor POEs of the same magnitude and direction. We see here that power decreases going from low to medium correlation and from medium to high correlation. We also see lower power when three phenotypes are affected when compared to the corresponding settings when only two of three phenotypes have POEs. This pattern, although unusual, has been documented in previous cross-phenotype methodological studies (Broadaway et al. 2016; Ray et al. 2016). As described in Section 2.2, the R-Omnibus test for equality of covariance matrices used by POIROT ultimately employs a one-way MANOVA test to generate our test statistic. Ray et al. describe how when we have K correlated traits being tested and a SNP is associated with all K traits, utilizing a MANOVA to find marginal associations with multiple traits can result in an appreciable loss of power. In particular, the authors show how the power of MANOVA is asymptotically lower when all traits are associated with equal magnitude and direction than when fewer than K phenotypes are associated (Ray et al. 2016).
3.3 Post hoc interaction test
Type I error results of our post hoc test for distinguishing POE (null) from general interaction effects (alternative) are shown in Supplementary Fig. S12. This is an illustrative example when only POEs exists for a sample size of 10 000 and the maternal POE effect size is 0.75. These results are indicative of all null simulation settings which show the test was well calibrated under the null when the only effects were parent-of-origin-dependent. Under alternative simulations with a GxE interaction effect, our post hoc test had the power to differentiate interaction effects from POEs (Supplementary Figs S13 and S14). Power is increasing with increasing number of phenotypes with non-null interaction effects, sample size, strength of interaction effect, and generally, pairwise trait correlation.
3.4 Applied data analysis
We applied our method for detecting POEs to genotype and multivariate phenotype data of 292 779 individuals of European ancestry from the UK Biobank. Raw quantitative phenotype measures of interest were BMI, HDL cholesterol, and LDL direct cholesterol. Phenotypes were appropriately adjusted for the effects of genotype array, PCs, sex, age, and smoking status. For the 330 801 variants considered, the average computation time per POIROT test was 22.53 s. Analysis was run with parallel computation with the genome segmented into 793 blocks with a maximum block runtime of 4.7 h (681 variants). We identified a total of 338 variants with POIROT p-values falling below the Bonferroni-adjusted genome-wide significance threshold of 1.5 × 10−7 (Supplementary Table S4). These suggestive POE variants are shown in the Manhattan plot in Fig. 4.
We also saw a significant positive normalized enrichment score (nominal P < .001) from the GSEA follow-up test, indicating that variants within 500 kb of imprinted or predicted-imprinted genes tended to lie at the top of our list ranked by increasing POIROT P-value. We next applied our post hoc test to these 338 identified variants to evaluate whether any demonstrated general interaction effects and observed that approximately two-thirds (230) had P > .05/338 and failed to reject the null of a POE. We similarly applied the univariate test for POEs genome-wide using each individual phenotype separately. Results are provided in Supplementary Figs S15–S17.
We report on the 41 variants identified by POIROT as potential POE loci that were not identified by any of the three univariate tests for POEs and further were not significantly demonstrating general interaction effects based on our post hoc test. These 41 variants thus represent the strongest evidence for novel POE effect(s) in our analysis. Among them, we highlight one exonic variant (Affx-20090007, POIROT P = 9.7 × 10−16) and one intronic variant (rs41360247, POIROT P = 3.0 × 10−13) on chromosome 2 for gene ABCG8. Polymorphisms in this gene have previously been associated with direct LDL in UKB samples (Klimentidis et al. 2020; Barton et al. 2021). Variants within this gene have additionally been associated with cholesterol phenotypes in analyses outside of the UK Biobank dataset (Willer et al. 2013). Of particular note, ABCG8 has been shown by prior research to be a high-confidence gene for maternal imprinting (Luedi et al. 2007). We also wish to highlight variants identified by POIROT around the gene APOB on chromosome 2. Of 14 POIROT-identified variants mapping to this gene, two failed to show evidence of significant interaction effects by our post hoc test [rs550619 (intronic, POIROT P = 3.1 × 10−10), rs74629722 (intergenic, POIROT P = 3.3 × 10−10)]. In particular, rs550619 lies 3299 bp from a previously published POE variant for BMI (rs1367117) (Hochner et al. 2015) and has significant GWAS associations with direct LDL levels and total cholesterol phenotypes (Klimentidis et al. 2020; Barton et al. 2021). Neither of these variants were identified for any of the three tested phenotypes using the existing univariate approach to detect POEs.
4 Discussion
In this article, we introduce a multivariate method, POIROT, for identifying common variants exhibiting POEs on one or more quantitative phenotypes in unrelated subjects. This work is motivated dually by the widespread evidence of pleiotropy in the genetics literature, as well as the limited statistical options for detecting POEs in unrelated cohorts. Our proposed method is an inherently simple statistical test of whether the phenotypic covariance matrix of heterozygotes is equal to that of homozygotes at a given locus. It represents a multivariate extension of the POE test of a single continuous phenotype proposed by Hoggart et al. (2014). It allows for appropriate adjustment for the effects of important covariates on the phenotypes under study and is also computationally efficient for application to biobank-scale datasets (Supplementary Tables S2 and S3). The R code for implementing POIROT is publicly available (see Data availability).
Through simulations, we demonstrate POIROT achieves appropriate type I error under the null. It further displays superior power to detect POEs than the competing univariate approach under most settings. Our method is indeed robust to non-normality of phenotypes across several simulation scenarios. We further applied our method to real GWAS data on white individuals of European ancestry from the UKB. In this analysis, we considered BMI as well as HDL and direct LDL cholesterol as potential imprinted phenotypes. The analysis revealed 338 variants meeting the stringent genome-wide significance threshold. Of these, 41 of may warrant particular focus in future investigations. They were not identified by the existing univariate approach to detect POEs and did not show evidence of significant gene–gene or gene–environment interaction effects using our proposed post hoc test. Two of these variants map to gene ABCG8, a gene with high confidence of maternal imprinting in humans based on previously published work, and another lies nearby a known POE variant for BMI in the gene APOB.
While the results presented here are promising for the utility of our proposed multivariate method for POE detection in practice, there are inherent limitations that we must address. Firstly, we propose POIROT as a method to detect SNPs wherein the effect of the variant allele in offspring differs according to which parent transmitted it. We do not evaluate the ability of our method to detect other trans-generational effects that may appear as imprinting effects at surface evaluation (Connolly and Heron 2015). Furthermore, we acknowledge that our method to detect POEs by evaluation of differing phenotypic covariance matrices by genotype groups may lead to false positive identifications at loci where gene–environment or gene–gene interaction effects exist. We have proposed a two-stage screening procedure to combat this: first by implementing POIROT as described, and second, by following up with our proposed test to distinguish which findings may be the result of more general interaction effects. We also note if a trans-generational effect exists by which, for example, the maternal genotype is affecting the offspring phenotype in a manner that is not completely independent of offspring genotype (in other words, there are maternal–fetal genotype interaction effects), we do believe we would be able to detect these in our post hoc test for interaction effects.
POIROT is a variance/covariance-based test for detecting POEs applicable to large population samples where allelic parental origin is unknown. If parental genetic information is known (i.e. through collection of parent-offspring trios), then it is well-established that variance-based tests within the offspring are often considerably less powerful than mean-based tests (like those described in the Section 1) that leverage allelic parental origin and look for differences in phenotypic means between heterozygous offspring with maternally- versus paternally inherited effect alleles (Struchalin et al. 2010). We performed additional simulations comparing the power of the two strategies at different sample sizes. Specifically, we simulated parent-offspring trio genotype data, restricted samples for analysis to include only heterozygous offspring, and tested for mean-based differences in phenotypes between offspring who inherited the variant alleles maternally versus those who inherited it paternally via one-way MANOVA. We assumed 2 out of 3, 6, or 10 phenotypes harbored a POE. We generally found that variance/covariance methods require ∼13 times as many observations as familial mean-based tests for equivalent power. The trio-based simulations assumed full knowledge of parental transmission of the variant allele in heterozygous offspring, when in reality, parent-of-origin may be ambiguous in certain cases. For details, please see Supplementary Fig. S18. Thus, if family-based data are available, we recommend the use of mean-based tests for POE detection rather than variance-based tests. For population studies, variance-based tests remain the only option for POE analysis.
There are several avenues we are interested in pursuing to extend the work presented here. Rather than testing genome-wide variants, implementation of a two-stage screening procedure may mitigate the multiple testing burden. In the first stage, we propose to perform a standard GWAS for marginal (not parent-of-origin dependent) variant associations that considers multiple traits jointly. We restrict consideration to marginal association tests that are orthogonal to POIROT and thus provide complementary information. We can then efficiently test a smaller subset of top SNPs identified from the first stage for POEs. Another limitation we acknowledge is the requirement of continuous phenotypes. We are interested in the possible extension of our approach to accommodate dichotomous multivariate traits. One potential solution would be to use liability-threshold models (Hujoel et al. 2020) that can effectively transform a binary outcome into a continuous-valued posterior mean genetic liability.
Supplementary Material
Acknowledgements
We thank the Associate Editor and two anonymous reviewers for their constructive comments on a previous version of this manuscript. The research for the applied analysis described in this article has been conducted using data from the UK Biobank, a major biomedical database (UK Biobank website: www.ukbiobank.ac.uk). Data were obtained via Application ID 58259.
Contributor Information
S Taylor Head, Department of Biostatistics and Bioinformatics, Rollins School of Public Health, Emory University, Atlanta, GA 30322, United States.
Elizabeth J Leslie, Department of Human Genetics, Emory University School of Medicine, Atlanta, GA 30322, United States.
David J Cutler, Department of Human Genetics, Emory University School of Medicine, Atlanta, GA 30322, United States.
Michael P Epstein, Department of Human Genetics, Emory University School of Medicine, Atlanta, GA 30322, United States.
Supplementary data
Supplementary data is available at Bioinformatics online.
Conflict of interest
None declared.
Funding
This work was supported by the National Institutes of Health [AG071170, DE029698, CA211574].
Data availability
The code for implementing this method in R is publicly available at https://github.com/staylorhead/POIROT-POE.
References
- Ainsworth HF, Unwin J, Jamison DL. et al. Investigation of maternal effects, maternal-fetal interactions and parent-of-origin effects (imprinting), using mothers and their offspring. Genet Epidemiol 2011;35:19–45. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Aypar U, Brodersen PR, Lundquist PA. et al. Does parent of origin matter? Methylation studies should be performed on patients with multiple copies of the Prader–Willi/Angelman syndrome critical region. Am J Med Genet 2014;164:2514–20. [DOI] [PubMed] [Google Scholar]
- Barlow DP. Genomic imprinting: a mammalian epigenetic discovery model. Annu Rev Genet 2011;45:379–403. [DOI] [PubMed] [Google Scholar]
- Barton AR, Sherman MA, Mukamel RE. et al. Whole-exome imputation within UK biobank powers rare coding variant association and fine-mapping analyses. Nat Genet 2021;53:1260–9. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Becker T, Baur MP, Knapp M. et al. Detection of parent-of-origin effects in nuclear families using haplotype analysis. Hum Hered 2006;62:64–76. [DOI] [PubMed] [Google Scholar]
- Box GEP. A general distribution theory for a class of likelihood criteria. Biometrika 1949;36:317–46. [PubMed] [Google Scholar]
- Broadaway KA, Cutler DJ, Duncan R. et al. A statistical approach for testing cross-phenotype effects of rare variants. Am J Hum Genet 2016;98:525–40. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Chesmore K, Bartlett J, Williams SM. et al. The ubiquity of pleiotropy in human disease. Hum Genet 2018;137:39–44. [DOI] [PubMed] [Google Scholar]
- Connolly S, Heron EA.. Review of statistical methodologies for the detection of parent-of-origin effects in family trio genome-wide association data with binary disease traits. Brief Bioinform 2015;16:429–48. [DOI] [PubMed] [Google Scholar]
- Cordell HJ, Barratt BJ, Clayton DG. et al. Case/pseudocontrol analysis in genetic association studies: a unified framework for detection of genotype and haplotype associations, gene-gene and gene-environment interactions, and parent-of-origin effects. Genet Epidemiol 2004;26:167–85. [DOI] [PubMed] [Google Scholar]
- Dong C, Li W-D, Geller F. et al. Possible genomic imprinting of three human obesity–related genetic loci. Am J Hum Genet 2005;76:427–37. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Gao X, Starmer J, Martin ER. et al. A multiple testing correction method for genetic association studies using correlated single nucleotide polymorphisms. Genet Epidemiol 2008;32:361–9. [DOI] [PubMed] [Google Scholar]
- Giannoukakis N, Deal C, Paquette J. et al. Parental genomic imprinting of the human IGF2 gene. Nat Genet 1993;4:98–101. [DOI] [PubMed] [Google Scholar]
- Guilmatre A, Sharp A.. Parent of origin effects. Clin Genet 2012;81:201–9. [DOI] [PubMed] [Google Scholar]
- He X, Zhang J.. Toward a molecular understanding of pleiotropy. Genetics 2006;173:1885–91. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Hochner H, Allard C, Granot-Hershkovitz E. et al. Parent-of-origin effects of the APOB gene on adiposity in young adults. PLoS Genet 2015;11:e1005573. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Hoggart CJ, Venturini G, Mangino M. et al. ; GIANT Consortium. Novel approach identifies SNPs in SLC2A10 and KCNK9 with evidence for parent-of-origin effect on body mass index. PLoS Genet 2014;10:e1004508. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Hotelling H. The generalization of student’s ratio. Ann Math Stat 1931;2:360–78. [Google Scholar]
- Howey R, Cordell HJ.. PREMIM and EMIM: tools for estimation of maternal, imprinting and interaction effects using multinomial modelling. BMC Bioinformatics 2012;13:149. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Howey R, Mamasoula C, Töpf A. et al. Increased power for detection of parent-of-origin effects via the use of haplotype estimation. Am J Hum Genet 2015;97:419–34. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Hujoel MLA, Gazal S, Loh P-R. et al. Liability threshold modeling of case–control status and family history of disease increases association power. Nat Genet 2020;52:541–7. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Huxtable SJ, Saker PJ, Haddad L. et al. Analysis of parent-offspring trios provides evidence for linkage and association between the insulin gene and type 2 diabetes mediated exclusively through paternally transmitted class III variable number tandem repeat alleles. Diabetes 2000;49:126–30. [DOI] [PubMed] [Google Scholar]
- Klimentidis YC, Arora A, Newell M. et al. Phenotypic and genetic characterization of lower LDL cholesterol and increased type 2 diabetes risk in the UK biobank. Diabetes 2020;69:2194–205. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Kocarnik JM, Fullerton SM.. Returning pleiotropic results from genetic testing to patients and research participants. JAMA 2014;311:795–6. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Kong A, Steinthorsdottir V, Masson G. et al. ; DIAGRAM Consortium. Parental origin of sequence variants associated with complex diseases. Nature 2009;462:868–74. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Lawson HA, Cheverud JM, Wolf JB. et al. Genomic imprinting and parent-of-origin effects on complex traits. Nat Rev Genet 2013;14:609–17. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Luedi PP, Dietrich FS, Weidman JR. et al. Computational and experimental identification of novel human imprinted genes. Genome Res 2007;17:1723–30. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Mootha VK, Lindgren CM, Eriksson K-F. et al. PGC-1α-responsive genes involved in oxidative phosphorylation are coordinately downregulated in human diabetes. Nat Genet 2003;34:267–73. [DOI] [PubMed] [Google Scholar]
- O’Brien PC. Robust procedures for testing equality of covariance matrices. Biometrics 1992;48:819–27. [Google Scholar]
- O’Reilly PF, Hoggart CJ, Pomyen Y. et al. MultiPhen: joint model of multiple phenotypes can increase discovery in GWAS. PLoS One 2012;7:e34861. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Palmer CGS, Hsieh H-J, Reed EF. et al. HLA-B maternal-fetal genotype matching increases risk of schizophrenia. Am J Hum Genet 2006;79:710–5. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Paré G, Cook NR, Ridker PM. et al. On the use of variance per genotype as a tool to identify quantitative trait interaction effects: a report from the women’s genome health study. PLoS Genet 2010;6:e1000981. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Peters J. The role of genomic imprinting in biology and disease: an expanding view. Nat Rev Genet 2014;15:517–30. [DOI] [PubMed] [Google Scholar]
- Polychronakos C, Kukuvitis A.. Parental genomic imprinting in endocrinopathies. Eur J Endocrinol 2002;147:561–9. [DOI] [PubMed] [Google Scholar]
- Rampersaud E, Mitchell BD, Naj AC. et al. Investigating parent of origin effects in studies of type 2 diabetes and obesity. Curr Diabetes Rev 2008;4:329–39. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Ray D, Pankow JS, Basu S. et al. USAT: a unified score-based association test for multiple phenotype-genotype analysis. Genet Epidemiol 2016;40:20–34. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Reik W, Walter J.. Genomic imprinting: parental influence on the genome. Nat Rev Genet 2001;2:21–32. [DOI] [PubMed] [Google Scholar]
- Sinsheimer JS, Palmer CGS, Woodward JA. et al. Detecting genotype combinations that increase risk for disease: maternal-fetal genotype incompatibility test. Genet Epidemiol 2003;24:1–13. [DOI] [PubMed] [Google Scholar]
- Solovieff N, Cotsapas C, Lee PH. et al. Pleiotropy in complex traits: challenges and strategies. Nat Rev Genet 2013;14:483–95. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Struchalin MV, Dehghan A, Witteman JC. et al. Variance heterogeneity analysis for detection of potentially interacting genetic loci: method and its limitations. BMC Genet 2010;11:92. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Subramanian A, Tamayo P, Mootha VK. et al. Gene set enrichment analysis: a knowledge-based approach for interpreting genome-wide expression profiles. Proc Natl Acad Sci USA 2005;102:15545–50. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Temple IK, James RS, Crolla JA. et al. An imprinted gene(s) for diabetes? Nat Genet 1995;9:110–2. [DOI] [PubMed] [Google Scholar]
- Tiku ML, Balakrishnan N.. Testing equality of population variances the robust way. Commun Stat Theory Methods 1984;13:2143–59. [Google Scholar]
- Vale CD, Maurelli VA.. Simulating multivariate nonnormal distributions. Psychometrika 1983;48:465–71. [Google Scholar]
- Wang K-S, Liu X, Zhang Q. et al. Parent-of-origin effects of FAS and PDLIM1 in attention-deficit/hyperactivity disorder. J Psychiatry Neurosci 2012;37:46–52. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Weinberg CR, Wilcox AJ, Lie RT. et al. A Log-Linear approach to case-parent–triad data: assessing effects of disease genes that act either directly or through maternal effects and that may be subject to parental imprinting. Am J Hum Genet 1998;62:969–78. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Weinberg CR. Methods for detection of parent-of-origin effects in genetic studies of case-parents triads. Am J Hum Genet 1999;65:229–35. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Willer CJ, Schmidt EM, Sengupta S. et al. Discovery and refinement of loci associated with lipid levels. Nat Genet 2013;45:1274–83. [DOI] [PMC free article] [PubMed] [Google Scholar]
- Zhou J-Y, Mao W-G, Li D-L. et al. A powerful parent-of-origin effects test for qualitative traits incorporating control children in nuclear families. J Hum Genet 2012;57:500–7. [DOI] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.
Supplementary Materials
Data Availability Statement
The code for implementing this method in R is publicly available at https://github.com/staylorhead/POIROT-POE.