Skip to main content
Bioinformatics logoLink to Bioinformatics
. 2019 Mar 26;35(20):4038–4044. doi: 10.1093/bioinformatics/btz176

SummaryAUC: a tool for evaluating the performance of polygenic risk prediction models in validation datasets with only summary level statistics

Lei Song 1,2, Aiyi Liu 3, Jianxin Shi 1,; Molecular Genetics of Schizophrenia Consortium 2
Editor: Russell Schwartz
PMCID: PMC6931355  PMID: 30911754

Abstract

Motivation

Polygenic risk score (PRS) methods based on genome-wide association studies (GWAS) have a potential for predicting the risk of developing complex diseases and are expected to become more accurate with larger training datasets and innovative statistical methods. The area under the ROC curve (AUC) is often used to evaluate the performance of PRSs, which requires individual genotypic and phenotypic data in an independent GWAS validation dataset. We are motivated to develop methods for approximating AUC of PRSs based on the summary level data of the validation dataset, which will greatly facilitate the development of PRS models for complex diseases.

Results

We develop statistical methods and an R package SummaryAUC for approximating the AUC and its variance of a PRS when only the summary level data of the validation dataset are available. SummaryAUC can be applied to PRSs with SNPs either genotyped or imputed in the validation dataset. We examined the performance of SummaryAUC using a large-scale GWAS of schizophrenia. SummaryAUC provides accurate approximations to AUCs and their variances. The bias of AUC is typically <0.5% in most analyses. SummaryAUC cannot be applied to PRSs that use all SNPs in the genome because it is computationally prohibitive.

Availability and implementation

https://github.com/lsncibb/SummaryAUC.

Supplementary information

Supplementary data are available at Bioinformatics online.

1 Introduction

Large-scale genome-wide association studies (GWAS) have identified dozens or even hundreds of common SNPs associated with many complex diseases, including psychiatric conditions, e.g. schizophrenia (Schizophrenia Working Group of the Psychiatric Genomics Consortium, 2014), type 2 diabetes (Scott et al., 2017) and common cancers, e.g. breast cancer (Michailidou et al., 2017) and prostate cancers (Al Olama et al., 2014). Heritability analysis using algorithms such as genome-wide complex trait analysis (GCTA) (Yang et al., 2010) and LD-score regressions (Bulik-Sullivan et al., 2015) have shown that, for many complex diseases, common SNPs have the potential to explain substantially larger fraction of the phenotypic variance than that based on the established GWAS SNPs, suggesting a great promise for genetic risk prediction. In fact, polygenic risk scores (PRSs) have been proven useful for predicting complex disease risk and are expected to become more accurate with large training datasets (Chatterjee et al., 2013; Dudbridge, 2013) and innovative statistical methods. For example, a PRS for schizophrenia based on tens of thousands of SNPs achieves an impressive prediction accuracy with an area under the receiver operating characteristic curve (AUC) of 0.75 (Schizophrenia Working Group of the Psychiatric Genomics Consortium, 2014) with ∼35 000 cases and 45 000 controls.

Much effort has been invested on developing PRS prediction models and on investigating the factors that determine the performance of PRSs. When raw genotypic and phenotypic data are available for the training dataset, machine learning algorithms (Kooperberg et al., 2010; Wei et al., 2009) and linear mixed models (Golan and Rosset, 2014; Maier et al., 2015; Speed and Balding, 2014) can be used to develop PRSs. PRSs can also be constructed when only GWAS summary level data are available for training dataset by simple P-value thresholding (Purcell et al., 2009) or by more sophisticated methods that model linkage disequilibrium (LD) (Vilhjalmsson et al., 2015). We have recently extended the P-value thresholding method to further improve accuracy by accounting for winner’s curse and by incorporating functional annotation data (Shi et al., 2016). Different aspects of building PRS are discussed in a recent review paper (Chatterjee et al., 2016).

Receiver operating characteristic (ROC) curve is one of the most popular tools for characterizing and comparing the diagnostic accuracy of binary classifier systems such as the PRSs in the present context. Since its first appearance in the Second World War for detecting enemy objects in battlefields, the ROC curve analysis has found its place in many others. A few books provide comprehensive coverage of the topics, see, among others (Hanley and Mcneil, 1982; Krzanowski and Hand, 2009; Pepe, 2003; Zou, 2011). The ROC curve of a PRS is generated by plotting its true positive rate against its false positive rate at various thresholds. The area under the ROC curve (AUC) provides a quantitative measure for the discrimination ability of a PRS (Hanley and Mcneil, 1982). AUC is the most frequently used quantitative measure for evaluating the discrimination performance of a PRS, although some concerns have been raised for using AUC as a criterion for model comparison and risk stratification (Katki and Schiffman, 2018). While AUC is defined as the area under the ROC curve, i.e. the integral of the curve, a more convenient mathematical expression of AUC is the probability that a randomly selected case has a larger PRS value than a randomly selected control. With this expression, one can show that an AUC estimator is closely related with the Mann–Whitney U statistic and the Wilcoxon rank test. Given PRS values for a set of cases and controls, one can easily calculate AUC using this approach and estimate the variance of the estimated AUC using bootstrap.

Calculating AUC for a PRS typically requires the individual level genotypic and phenotypic data in an independent GWAS validation dataset. One solution is to genotype a large set of subjects as a new validation GWAS dataset, which is financially expensive and time consuming. Another possibility is to request individual level data from existing large-scale GWAS independent of the training GWAS, which is also time consuming and may turn out to be infeasible because of data sharing policies. Instead, requesting summary statistics [odds ratio (OR), P-value and imputation quality for individual SNPs] from an independent validation GWAS consortium is much easier because such summary statistics are usually available online with open access. Thus, developing methods for evaluating the performance of PRSs based on the summary statistics of validation GWAS would substantially accelerate the assessment of PRSs for specific diseases and facilitate the development of more accurate PRSs.

In this manuscript, we develop a statistical method, termed as ‘SummaryAUC’, for approximating AUC and its variance for a given PRS based on summary statistics from an independent GWAS validation dataset. Although SummaryAUC relies on the normality assumption of PRS, extensive simulation studies demonstrate that it is highly accurate under realistic situations with more than five SNPs. Furthermore, SummaryAUC is flexible for PRSs with independent SNPs or SNPs in weak LD and for both genotyped and imputed SNPs in the validation dataset. Finally, we applied SummaryAUC to schizophrenia GWAS to demonstrate the validity of the methods. SummaryAUC is best used for PRSs with independent SNPs and for PRSs with <20 000 SNPs in weak LD for both accuracy and computational efficiency. SummaryAUC is not suitable for PRSs integrating all common SNPs in the genome, e.g. LD-Pred (Vilhjalmsson et al., 2015) and BLUP-type PRSs (Golan and Rosset, 2014; Speed and Balding, 2014) based on linear mixed models. An R package with the same name was developed to implement the proposed method and is publicly available.

2 Materials and methods

We assume an additive PRS model based on M SNPs:

PRSi=m=1Mwmgim, (1)

where m indexes SNPs and i indexes subjects in the validation dataset. The weights (w1,,wM) are derived based on a specific algorithm and a training dataset. The genotypic value gim{0,1,2} if the SNP is genotyped and gim[0, 2] if the SNP is imputed. The selected SNPs in the PRS may be correlated because of LD.

When the genotypic data and the binary phenotypic data (yi) are available for each individual subject in the validation dataset, one can calculate PRS in (1) for all subjects and evaluate the performance of the prediction model by comparing PRS with the known phenotypic data. The performance of a prediction model is often assessed by the area under the AUC at the observational scale.

We are interested in developing methods for estimating AUC and its standard deviations when only the GWAS summary statistics are available for the validation dataset. For the mth SNP, the summary statistics include the minor allele, the minor allele frequency (MAF) in the control samples, the ORm or equivalently the regression coefficient βm=log(ORm), the two-sided P-value Pm or equivalently the Z-score statistic Zm=signβmΦ-1(1-Pm/2), the imputation information score rm2, the number of cases n1 and the number of controls n0. Here, βm and Pm are based on single variant logistic regression. Φ() is the cumulative distribution function for N(0, 1). In addition, MAF may not be available from the summary statistics to prevent subjects in the study to be deidentified (Homer et al., 2008; Jacobs et al., 2009).

2.1 Estimating AUC and its variance by summary statistics

Let PRS1i=m=1Mwmgim1 be PRS for the ithcase and PRS0j=m=1Mwmgjm0 for the jth control subject. We assume that M is reasonably large that PRSs approximately follow normal distributions in cases and controls, respectively:

PRS1iNμ1,σ12 and PRS0jNμ0,σ02. (2)

We will investigate the impact of the normality assumption in numerical studies. We define

Δ=μ1-μ0 σ12+σ02. (3)

The AUC (denoted as θ) is defined as the probability that, for a randomly selected case and a randomly selected control, the case has a larger PRS than the control, i.e. θ=P(PRS1i>PRS0j). For a validation dataset with n1 cases and n0 controls with individual PRS values, one can estimate the AUC based on the following U-statistic (or the Wilcoxon–Mann–Whitney statistic):

θ^=1n0n1i=1n1j=1n0I(PRS1i>PRS0j). (4)

The expectation of AUC assuming normal distributions defined in (2) can be calculated as

θ=P(PRS1i> PRS0j)=P((PRS1i> PRS0j)(μ1μ0)σ12+σ02>(μ1μ0) σ12+σ02)= Φ(Δ). (5)

When n11, n01 and σ12σ02 (when common SNPs have modest effect sizes for complex diseases), we derive in Supplementary Appendix that

Varθ^=n1+n0n1n0Pz1>-Δ, z2>-Δ-Φ2Δ, (6)

where z1N(0,1), z2N(0,1) and corz1,z2=1/2 If a PRS has rare SNPs with large effect size, variance is derived in Supplementary Appendix (A8) without assuming σ12σ02.

Note that both AUC (5) and the variance of the AUC estimator (6) depend on Δ defined in (3). Thus, it remains to estimate Δ based on the summary statistics in the validation dataset.

2.2 Estimate Δ when SNPs are independent

Let p1m and p0m denote the MAF of SNP m in the case and the control group, respectively. Typically, p0m is included in the GWAS summary data while p1m is not included. p1m=p0m/(p0mORm+1-p0m), where ORm is the OR in the validation dataset. Let τ0m2=Var(gjm0)=2p0m1-p0mrm2 be the genotypic variance in the control group assuming the Hardy Weinberg Equilibrium law. Similarly, let τ1m2=Vargim1=2p1m1-p1mrm2 be the genotypic variance in the case group. Remember that we assume PRS1iN(μ1,σ12) and PRS0jN(μ0,σ02) approximately in (2). When SNPs in the PRS are independent, we have μ1=m=1M2wmp1m, μ0=m=1M2wmp0m, σ12=m=1Mwm2τ1m2 and σ02=m=1Mwm2τ0m2.

Substituting these into (3) leads to

Δ=μ1-μ0 σ12+σ02=m=1M2wm(p1m-p0m)m=1Mwm2(τ1m2+τ0m2). (7)

Thus, it remains to estimate p1m-p0m, the difference of the allele frequencies between cases and controls.

Let Gm1 and Gm0 be the average genotypic values in the case group and the control group, respectively. One can estimate p1m-p0m as

p^1m-p^0m=(Gm1-Gm0)/2. (8)

The Z-statistic for genetic association can be approximated by the t-statistic for large studies, i.e. Zm=(Gm1-Gm0)/τ1m2/n1+τ0m2/n0; thus, we have

Gm1-Gm0Zmτ1m2/n1+τ0m2/n0. (9)

Combining (7), (8) and (9) leads to an estimate for Δ:

Δ^=m=1MwmZmτ1m2/n1+τ0m2/n0m=1Mwm2(τ1m2+τ0m2). (10)

When p0m is not included in the summary statistics, we can use the allele frequency based on public data (e.g. The 1000 Genome Project) of the similar ancestry populations to approximate τ0m2 and τ1m2.

2.3 Estimate Δ when SNPs are in LD

We first assume that SNPs in PRS are genotyped in the validation dataset. When some SNPs in PRS are in LD, we only need to modify the denominator in (10). We assume that, for complex diseases, correlations between local SNPs are similar in cases and controls. This assumption is reasonable because ORs are modest for nearly all disease-associated SNPs. Let ρml=cor(gim,gil) be the genotypic correlation between SNP m and SNP l. The variance of PRS in controls and cases are

VarPRS0j=m=1Mwm2τ0m2+2m<lwmwlτ0mτ0lρml

and

VarPRS1i=m=1Mwm2τ1m2+2m<lwmwlτ1mτ1lρml.

Thus, (10) can be modified as

Δ^=m=1MwmZmτ1m2/n1+τ0m2/n0m=1Mwm2(τ1m2+τ0m2)+2m<lwmwl(τ0mτ0l+τ1mτ1l)ρml. (11)

In implementation, we assume ρml=0 for SNPs located on different chromosomes and for SNPs on the same chromosome but more than 5 Mb away. In addition, we estimated ρml using the genotype data of the similar ancestry population in The 1000 Genomes Project.

However, it is very challenging when SNPs in the PRS are imputed. Let g^imbe the imputed genotypic dosage. Let ρ'ml=cor(g^im,g^il) be the correlation between the imputed genotypic dosages. Although we cannot rigorously prove, we observe that imputation tends to inflate the magnitude of pairwise correlation, particularly for SNPs imputed with high uncertainty. We find that using ρml (calculated based on genotype data in external data) to calculate Δ^ in (11) makes the approximation to AUC and its variance less accurate, particularly when a PRS has many SNPs. To address this problem, we propose a strategy to estimate ρ'ml using The 1000 Genome Project data, which is illustrated in Figure 1. Briefly, the subjects in The 1000 Genome Project with relevant ancestry are divided into two sets, denoted as S1 and S2. For subjects in S1, we keep only SNPs that are genotyped in the validation GWAS dataset and perform imputation to derive genotypic dosages using the haplotypes in S2 as the reference panel. We can calculate ρ'ml=cor(g^im,g^il) using the imputed genotypic dosages to approximate Δ^ in (11). Obviously, the degree of uncertainty of imputed genotypes is similar to that in the validation GWAS dataset because they are based on the same set of genotyped SNPs. Thus, we expect this strategy to attenuate the impact of imputation to the calculation of LD and thus to improve the approximation to AUC and its variance.

Fig. 1.

Fig. 1.

Estimate correlation of imputed SNPs in the validation GWAS dataset. The subjects in The 1000 Genome Project with relevant ancestry are divided as two sets S1 and S2. (A) The genotype of the subjects in S1. (B) Only SNPs that are genotyped in the validation GWAS dataset are kept. (C) The haplotypes in S2 are used as reference panel for imputation. (D) Imputation is performed to derive the genotypic dosage for SNPs that are not genotyped in the validation GWAS dataset. The correlation between two SNPs is calculated based on the imputed genotypic dosages

3 Results

3.1 Implementation

We implemented our algorithms in an R package ‘SummaryAUC’, which is freely available online. Pairwise correlations between SNPs are estimated using the genotype data in the The 1000 Genome Project with relevant ancestry. For PRS with practically independent SNPs (e.g. SNPs pruned rigorously), there is no limitation on the number of SNPs in PRS. When SNPs in a PRS are correlated, we only adjust for correlations for SNP pairs that are <5 Mb away. In real data analyses, most PRSs have <10 000 SNPs, which can be calculated in a few minutes.

3.2 Simulation studies

The key assumption of SummaryAUC is that PRS follows a normal distribution approximately. This assumption may lead to poor approximation to AUC when the number of SNPs (M) in a PRS is small. Thus, we performed simulations to investigate whether and how the accuracy of SummaryAUC depends on M. In each simulation, we simulated genotypes for 3000 cases and 3000 controls and for M independent SNPs (M = 5,10,⋯,100). The allele frequency p0m in controls followed a uniform distribution U(0.05, 0.5). We simulated βm=log(ORm)N(0, 1/32). The coefficients for PRS were set as the simulated β values. The allele frequency p0m in cases were calculated as p1m=ORmpom/(ORmpom+1-pom), where ORm is the OR for the SNP in the validation sample. Genotypic data were simulated using binomial distribution separately for cases and controls.

For each set of simulated data, we calculated AUC and its variance in two ways. In the first approach, we calculated PRS for each individual subject using the individual genotypic values; we then calculated AUC using an R package ‘AUC’ and its variance using bootstrap (N = 10 000). In the second approach, we first performed association test for each SNP to derive Zm and also allele frequency p0m for control samples; we then approximated AUC and its variance using SummaryAUC.

The simulation results are summarized in Figure 2. Results suggest that SummaryAUC provides accurate approximation to AUC and its variance even when PRS has only five SNPs. Note that the correlation between true AUC and approximated AUC is >99%. Thus, the performance of SummaryAUC is robust to the number of SNPs in PRS.

Fig. 2.

Fig. 2.

AUC values and the standard errors for PRS with independent SNPs based on simulation study. Each data point represents one simulation. For each simulation, we calculated the AUC and its variance based on individual data (x-coordinate) and using SummaryAUC (y-coordinate)

Next, we also performed simulations by simulating βm=log(ORm)N(0,1/22), N(0,1) and 0.25+U(0,0.5). The 90% quantile of the simulated ORs are 2.28, 5.2 and 2.01, respectively. These values are quite big for common SNPs and polygenic diseases. Results are reported in Supplementary Figures S1–S3. Again, SummaryAUC provides good approximations.

Finally, we performed simulations using SNPs that have been reported to be associated with nine complex diseases, including multiple autoimmune diseases and cancers (Supplementary Fig. S4A). The number of SNPs in PRSs ranged from 19 (melanoma) to 165 (prostate cancer). We used the published ORs and reference allele frequencies in the European ancestry for simulations. For most of the nine diseases, there was one common SNP with OR much bigger than the other SNPs (Supplementary Fig. S4B), providing an opportunity to check the robustness of SummaryAUC in presence of outliers in ORs. In all simulations, SummaryAUC provided accurate approximation to AUCs and their variances. Simulation results are summarized in Supplementary Figures S5 and S6.

3.3 Application to genetic risk prediction of schizophrenia

We evaluated the performance of SummaryAUC using schizophrenia GWAS (Schizophrenia Working Group of the Psychiatric Genomics, 2014). Schizophrenia is a devastating psychiatric disorder with high heritability (80–85%) and has a prevalence of ∼1% worldwide. Schizophrenia is highly polygenic and estimated to be caused by more than 10 000 common SNPs. The Schizophrenia Working Group of Psychiatric Genetics Consortium (PGC) recently performed a meta-analysis of 49 case-control studies (34 241 cases and 45 604 controls) and 3 family studies (1235 parent affected offspring trios) and identified 108 genome-wide significant common SNPs. Encouragingly, PRSs have achieved a high discrimination performance with average AUC ∼75% by leave-one-out analysis. Thus, this dataset is very useful for evaluating the performance of SummaryAUC because we can choose PRS with wide range of AUC values. Another advantage of using schizophrenia GWAS data is that the performance is typically maximized when most of SNPs are included in the PRS (Schizophrenia Working Group of the Psychiatric Genomics, 2014), i.e. the P-value threshold for including SNPs in PRS is nearly one. Thus, we can evaluate the accuracy of our method in presence of extensive correlations between SNPs.

PRSs were constructed using the results of a fixed-effect meta-analysis using all sub studies excluding the Molecular Schizophrenia Genetics (MGS) study (Shi et al., 2009). The MGS study (2681 cases and 2653 controls of European ancestry) was used to calculate AUC values as the independent validation dataset. The meta-analysis results included P-values Pm and ORm based in single variant logistic regression analysis. Let wm=logORm, PRSs were built in two steps following Purcell’s approach (Purcell et al., 2009): (1) LD-clumping using pairwise correlation threshold r. LD-clumping was guided by the association P-values in the training dataset to keep the SNPs with smaller P-values in each specified short interval. After LD-clumping, reminding SNPs (denoted as Ar) had pairwise correlation less than r. (2) The PRS was defined as PRSiQ,r=mAr;Pm<Qwmgim for a given P-value threshold Q. Note that the number of SNPs in PRS increases with Q and r. We chose a wide range of P-value threshold, ranging from 5 × 10−8 (genome-wide significance) to 1 (i.e. all SNPs in Ar). To investigate how the pairwise correlation in SNPs impacted the performance, we chose r2=0.01 (very stringent, SNPs practically independent), 0.1 and 0.2 (locally, modestly correlated).

3.3.1 Compare performance when SNPs are genotyped in MGS

In the first set of analyses, we compared AUCs and SEs for PRSs restricted to genotyped SNPs in the MGS dataset. For each PRS, we calculated AUC and its standard error (SE) using MGS as the validation dataset in two ways. First, we assumed that individual level genotype/phenotype data in MGS were available, calculated PRS for each subject in MGS and calculated AUC using an R package ‘AUC’. Then, we performed bootstrap (N = 10 000) to estimate the SEs of the estimated AUC values. We denote the two values as AUC0 and SE0. Second, we performed single variant logistic regression to derive P-values, allele frequencies in controls and ORs for all common SNPs, adjusting for sex, age and the top 10 Principal component analysis (PCA) scores. The AUC and its SE were calculated using SummaryAUC. We denote the two values as AUC1 and SE1.

Results are reported in Figure 3. As was reported previously (Purcell et al., 2009; Schizophrenia Working Group of the Psychiatric Genomics Consortium, 2014), including more SNPs in PRS increases AUC for schizophrenia because of the extremely highly polygenic genetic architecture. When SNPs are practically independent with pruning criteria r2=0.01, AUC0 and AUC1 agree very well with the largest difference |AUC0 − AUC1| = 0.37%. When we allow SNPs to be weakly correlated with pruning criteria r2=0.2, we observed highly concordant results until P-value threshold <0.1, where the largest difference |AUC0 − AUC1| = 0.31%. When we included SNPs with more liberal P-values, we observed larger inconsistency but the difference is still acceptable with the largest difference |AUC0 − AUC1| = 0.63% when all SNPs (122 552 SNPs) after pruning are included in PRS. Because we only ran 10 000 bootstrap samples to derive SE0, there is some fluctuation across PRS models. Apparently, SE1 provides an accurate approximation to SE0.

Fig. 3.

Fig. 3.

AUC values and their standard errors for PRS of schizophrenia for genotyped SNPs in the MGS study. PRSs were trained based on the PGC summary data excluding the MGS study; the MGS study was used as the validation data for calculating AUC and its variance. Analysis was restricted to SNPs genotyped in MGS. The x-coordinate is the P-value threshold (for training dataset) for including SNPs in PRS. AUC0 and SE0 were calculated using individual level data. AUC1 and SE1 were calculated using SummaryAUC based on GWAS summary data in MGS. r2=0.01: SNPs were LD-clumped using r2=0.01 in PLINK. r2=0.2: SNPs were LD-clumped using r2=0.2 in PLINK

To empirically examine the accuracy for PRSs with a small number of SNPs, we examined the performance of SummaryAUC for PRS with the number of SNPs varying from 5 to 100 (Fig. 4). When r2=0.01, the largest difference |AUC0-AUC1| = 0.41%; when r2=0.2, the largest difference |AUC0 − AUC1| = 0.55%. SE1 values also agree well although SE0 fluctuates because of the limited number of bootstrap samples.

Fig. 4.

Fig. 4.

AUC values and their standard errors for PRS of schizophrenia for genotyped SNPs in validation dataset. PRSs were trained based on the PGC data excluding the MGS study; the MGS study was used as the validation data for calculating AUC and its variance. The x-coordinate is the number of SNPs (with smallest P-values in the training dataset) for PRS. AUC0 and SE0 were calculated assuming individual level data. AUC1 and SE1 were calculated using SummaryAUC based on GWAS summary data in MGS. r2=0.01: SNPs were LD-clumped using r2=0.01 in PLINK. r2=0.2: SNPs were LD-clumped using r2=0.2 in PLINK

3.3.2 Compare performance when SNPs are imputed in MGS

MGS samples were imputed using software IMPUTE2 (Howie et al., 2009) and using the haplotypes in The 1000 Genome Project as the reference. SNPs with imputation R2<0.5 were excluded from analyses. Again, AUC0 and SE0 were calculated using individual level data. AUC1 and SE1 were calculated using SummaryAUC with ρml=cor(gim, gil) estimated directly using the genotype data in The 1000 Genome Project. AUC2 and SE2 were calculated using SummaryAUC with ρ'ml=cor(g^im,g^il) estimated using the imputed genotypic dosage data for samples in The 1000 Genome Project, as illustrated in Figure 1.

Results are presented in Figure 5. When SNPs were very rigorously pruned with r2=0.01, both methods approximated AUCs and their standard errors very well. When SNPs were pruned with r2=0.2, both AUC1 and AUC2 approximate AUC0 very well when the P-value threshold <0.01. In fact, when P-value threshold =0.01, the PRS has 27 404 SNPs. When PRSs use more liberal P-value threshold to increase the number of SNPs, precisely adjusting for local correlation between SNPs becomes more important but difficult for SummaryAUC. In this case, AUC1 does not approximate AUC0 very well with the largest bias |AUC0 − AUC1| = 2.25%. This is because AUC1 uses ρml=cor(gim, gil) estimated directly using the genotype data in The 1000 Genome Project. In fact, imputation may change the correlation for imputed SNPs, particularly for poorly imputed SNPs. Encouragingly, AUC2 better approximates AUC0 with the largest bias |AUC0 − AUC2| = 1.30%. The remaining bias may be due to the subtle difference of LD between the external genotype and the MGS population. A similar pattern is observed for SE0, SE1 and SE2.

Fig. 5.

Fig. 5.

AUC values and their standard errors for PRS of schizophrenia when SNPs are imputed. PRSs were trained based on the PGC data excluding the MGS study; the MGS study was used as the validation data for calculating AUC and its variance. MGS samples were imputed using IMPUTE2 and the haplotypes in The 1000 Genome Project. AUC0 and SE0 were calculated assuming individual level data. AUC1 and SE1 were calculated using SummaryAUC based on GWAS summary data in MGS, where pairwise SNP correlation was estimated using the genotype in The 1000 Genome Project directly. AUC2 and SE2 were calculated using SummaryAUC based on the summary data in MGS, where pairwise correlation was estimated using the imputed genotypic dosage data illustrated in Figure 1. r2=0.01: SNPs were LD-clumped using r2=0.01 in PLINK. r2=0.2: SNPs were LD-clumped using r2=0.2 in PLINK

4 Discussions

Although the predictive performance of PRS models are relatively poor for most of complex diseases, PRS will be improved by increasing the sample size of the training GWAS dataset and innovative statistical methods that incorporate additional biological information, e.g. functional annotation data and genetic pleiotropy (T.Chen et al., submitted for publication; Hu et al., 2017; Shi et al., 2016). One difficulty for developing more accurate PRS is to evaluate the predictive performance of PRS in independent GWAS, which requires individual level genotypic and phenotypic data. Herein, we develop SummaryAUC as a new statistical method for approximating AUC and its standard error based on GWAS summary level data, which will greatly facilitate the development of more accurate PRS models.

Although SummaryAUC was derived under the normality assumption of PRS, simulation results suggest that the performance of SummaryAUC is robust to the number of SNPs in PRS. In fact, we found that SummaryAUC was accurate even for PRS with only five SNPs.

We systematically examined the accuracy of SummaryAUC by applying it to schizophrenia GWAS. Because of the extremely polygenic genetic architecture and the very large sample size in the training dataset, PRS can reach as high as 75% when all SNPs after LD-pruning are included. These data are very useful for examining the performance of SummaryAUC because we can compare accuracy for a wide range of AUC and for PRSs with tens of thousands of SNPs. The observations from this numerical study can be summarized as follows.

First, when SNPs in PRS are practically independent after rigorous LD-pruning, SummaryAUC is most accurate and the accuracy is not compromised even when all SNPs (after pruning) are included in PRS. In this case, computation is very fast.

Second, if locally correlated, genotyped SNPs are included in PRS, the performance is only slightly compromised compared to that based on independent SNPs. Because we have to adjust for local correlation, the computation might be slightly slow. In our implementation, we set ρml=0 for SNPs on different chromosomes or on the same chromosome but 5 Mb away; thus, computation can be done within a few minutes even when PRS has tens of thousands of SNPs.

Third, it is more complicated when PRS has correlated SNPs that are imputed in the validation GWAS dataset. When PRS is reasonably sparse (e.g. <20 000 SNPs), SummaryAUC is still accurate. However, when PRS has many SNPs (e.g. when including SNPs using P-value threshold 0.01), SummaryAUC is less accurate if pairwise correlations are not appropriately adjusted. In this case, an imputation-based method helps to reduce the bias. In reality, this only applies to schizophrenia and a few other psychiatric disorders because of their highly polygenic genetic architecture. For most of other diseases, the PRS with optimal classification accuracy is sparse, typically with <2000 SNPs. Thus, we expect SummaryAUC to work well.

Thus, if PRSs use independent SNPs, SummaryAUC can be used with confidence for PRS with any size and for both genotyped and imputed SNPs. If PRSs use correlated SNPs that are imputed in validation GWAS dataset, SummaryAUC is most accurate for sparse PRS models and needs to adjust correlations using imputed dosage data only for very dense PRS models. In addition, SummaryAUC is not suitable for PRSs using all common SNPs in the genome, e.g. LD-Pred (Vilhjalmsson et al., 2015) and BLUP-type PRSs (Golan and Rosset, 2014; Speed and Balding, 2014) that are based on linear mixed models. It is computationally infeasible to adjust for the correlation for multiple millions of SNPs.

In addition, we found from simulations that, if summary statistics in the validation dataset were not appropriately corrected for population stratification, SummaryAUC may overestimate AUC. Thus, we recommend checking the quantile–quantile plot and running LD-score regression (Bulik-Sullivan et al., 2015) to estimate the extent of population stratification. If population stratification is a major concern for a validation dataset (e.g. cases and controls are from different studies), it should not be used for evaluating AUC for a PRS. Finally, if the summary level data based on pooling multiple studies are used for validation, we need to consider heterogeneity (differences in ORs and allele frequencies for SNPs in PRS) across these studies. If evidence suggests strong and extensive heterogeneity across studies, the pooled dataset should not be used as the validation dataset and effort must be made to perform validation for individual studies.

Currently, we are working on developing methods for approximating R2=cor2(yi,PRSi) using GWAS summary data in the validation dataset, the fraction of phenotypic variance explained by a PRS model at the observational scale. In addition, we are working on developing statistical methods for testing whether the AUC values from two PRS models are statistically different using GWAS summary data.

Supplementary Material

btz176_Supplementary_Data

Acknowledgements

This study utilized the high-performance computational capabilities of the Biowulf Linux cluster at the National Institutes of Health, Bethesda, MD (http://biowulf.nih.gov). The Molecular Genetics of Schizophrenia (MGS) Consortium includes P.V. Gejman, A.R. Sanders, J. Duan (North Shore University Health System and University of Chicago), C.R. Cloninger, D.M. Svrakic (Washington University, St Louis), N.G. Buccola (Louisiana State University Health Sciences Center, New Orleans), D.F. Levinson, J.S. (Stanford University, Stanford, California; Dr. J.S. is now at the National Cancer Institute), B.J. Mowry (Queensland Centre for Mental Health Research, Brisbane, and Queensland Brain Institute, University of Queensland, Brisbane), R. Freedman, A. Olincy (University of Colorado Denver), F. Amin (Atlanta Veterans Affairs Medical Center and Emory University, Atlanta), D.W. Black (University of Iowa Carver College of Medicine, Iowa City), J.M. Silverman (Mount Sinai School of Medicine, New York) and W.F. Byerley (University of California, San Francisco).

Funding

The project was supported by the NIH Intramural Research program.

Conflict of Interest: none declared.

Contributor Information

Molecular Genetics of Schizophrenia Consortium:

P V Gejman, A R Sanders, J Duan, C R Cloninger, D M Svrakic, N G Buccola, D F Levinson, B J Mowry, R Freedman, A Olincy, F Amin, D W Black, J M Silverman, and W F Byerley

References

  1. Al Olama A.A. et al. (2014) A meta-analysis of 87,040 individuals identifies 23 new susceptibility loci for prostate cancer. Nat. Genet., 46, 1103–1109. [DOI] [PMC free article] [PubMed] [Google Scholar]
  2. Bulik-Sullivan B.K. et al. (2015) LD score regression distinguishes confounding from polygenicity in genome-wide association studies. Nat. Genet., 47, 291–295. [DOI] [PMC free article] [PubMed] [Google Scholar]
  3. Chatterjee N. et al. (2013) Projecting the performance of risk prediction based on polygenic analyses of genome-wide association studies. Nat. Genet., 45, 400–405. [DOI] [PMC free article] [PubMed] [Google Scholar]
  4. Chatterjee N. et al. (2016) Developing and evaluating polygenic risk prediction models for stratified disease prevention. Nat. Rev. Genet., 17, 392–406. [DOI] [PMC free article] [PubMed] [Google Scholar]
  5. Dudbridge F. (2013) Power and predictive accuracy of polygenic risk scores. PLoS Genet., 9, e1003348. [DOI] [PMC free article] [PubMed] [Google Scholar]
  6. Golan D., Rosset S. (2014) Effective genetic-risk prediction using mixed models. Am. J. Hum. Genet., 95, 383–393. [DOI] [PMC free article] [PubMed] [Google Scholar]
  7. Hanley J.A., Mcneil B.J. (1982) The meaning and use of the area under a receiver operating characteristic (Roc) curve. Radiology, 143, 29–36. [DOI] [PubMed] [Google Scholar]
  8. Homer N. et al. (2008) Resolving individuals contributing trace amounts of DNA to highly complex mixtures using high-density SNP genotyping microarrays. PLoS Genet., 4, e1000167. [DOI] [PMC free article] [PubMed] [Google Scholar]
  9. Howie B.N. et al. (2009) A flexible and accurate genotype imputation method for the next generation of genome-wide association studies. PLoS Genet., 5, e1000529. [DOI] [PMC free article] [PubMed] [Google Scholar]
  10. Hu Y. et al. (2017) Joint modeling of genetically correlated diseases and functional annotations increases accuracy of polygenic risk prediction. PLoS Genet., 13, e1006836. [DOI] [PMC free article] [PubMed] [Google Scholar]
  11. Jacobs K.B. et al. (2009) A new statistic and its power to infer membership in a genome-wide association study using genotype frequencies. Nat. Genet., 41, 1253–1257. [DOI] [PMC free article] [PubMed] [Google Scholar]
  12. Katki H.A., Schiffman M. (2018) A novel metric that quantifies risk stratification for evaluating diagnostic tests: the example of evaluating cervical-cancer screening tests across populations. Prev. Med., 110, 100–105. [DOI] [PMC free article] [PubMed] [Google Scholar]
  13. Kooperberg C. et al. (2010) Risk prediction using genome-wide association studies. Genet. Epidemiol., 34, 643–652. [DOI] [PMC free article] [PubMed] [Google Scholar]
  14. Krzanowski W.J., Hand D.J. (2009) ROC Curves for Continuous Data. Chapman & Hall, CRC Press, London. [Google Scholar]
  15. Maier R. et al. (2015) Joint analysis of psychiatric disorders increases accuracy of risk prediction for schizophrenia, bipolar disorder, and major depressive disorder. Am. J. Hum. Genet., 96, 283–294. [DOI] [PMC free article] [PubMed] [Google Scholar]
  16. Michailidou K. et al. (2017) Association analysis identifies 65 new breast cancer risk loci. Nature, 551, 92–94. [DOI] [PMC free article] [PubMed] [Google Scholar]
  17. Pepe M.S. (2003) The Statistical Evaluation of Medical Tests for Classification and Prediction. Oxford University Press. [Google Scholar]
  18. Purcell S.M. et al. (2009) Common polygenic variation contributes to risk of schizophrenia and bipolar disorder. Nature, 460, 748–752. [DOI] [PMC free article] [PubMed] [Google Scholar]
  19. Schizophrenia Working Group of the Psychiatric Genomics Consortium. (2014) Biological insights from 108 schizophrenia-associated genetic loci. Nature, 511, 421–427. [DOI] [PMC free article] [PubMed] [Google Scholar]
  20. Scott R.A. et al. (2017) An expanded genome-wide association study of type 2 diabetes in Europeans. Diabetes, 66, 2888–2902. [DOI] [PMC free article] [PubMed] [Google Scholar]
  21. Shi J. et al. (2009) Common variants on chromosome 6p22.1 are associated with schizophrenia. Nature, 460, 753–757. [DOI] [PMC free article] [PubMed] [Google Scholar]
  22. Shi J. et al. (2016) Winner’s curse correction and variable thresholding improve performance of polygenic risk modeling based on genome-wide association study summary-level data. PLoS Genet., 12, e1006493. [DOI] [PMC free article] [PubMed] [Google Scholar]
  23. Speed D., Balding D.J. (2014) MultiBLUP: improved SNP-based prediction for complex traits. Genome Res., 24, 1550–1557. [DOI] [PMC free article] [PubMed] [Google Scholar]
  24. Vilhjalmsson B.J. et al. (2015) Modeling linkage disequilibrium increases accuracy of polygenic risk scores. Am. J. Hum. Genet., 97, 576–592. [DOI] [PMC free article] [PubMed] [Google Scholar]
  25. Wei Z. et al. (2009) From disease association to risk assessment: an optimistic view from genome-wide association studies on type 1 diabetes. PLoS Genet., 5, e1000678. [DOI] [PMC free article] [PubMed] [Google Scholar]
  26. Yang J. et al. (2010) Common SNPs explain a large proportion of the heritability for human height. Nat. Genet., 42, 565–569. [DOI] [PMC free article] [PubMed] [Google Scholar]
  27. Zou K.H. et al. (2011) Statistical Evaluation of Diagnostic Performance: Topics in ROC Analysis. Chapman and Hall, CRC. [Google Scholar]

Associated Data

This section collects any data citations, data availability statements, or supplementary materials included in this article.

Supplementary Materials

btz176_Supplementary_Data

Articles from Bioinformatics are provided here courtesy of Oxford University Press

RESOURCES