Skip to main content

VARPRISM: incorporating variant prioritization in tests of de novo mutation association

Abstract

Background

Patients with certain genetic diseases, such as autism spectrum disorder, have increased rates of de novo mutations within some protein-coding genes.

Results

We introduce the VARiant PRIoritization SuM (VARPRISM), a software package which incorporates functional variant prioritization information to improve the power to detect de novo mutations influencing disease risk. VARPRISM evaluates the consequence of any given exonic mutation on the protein sequence to estimate the likelihood that the mutation is benign or damaging and conducts a likelihood ratio test on the gene level. We analyzed the Simons Simplex Collection of 2508 parent-offspring autism trios using VARPRISM, replicating 44 genes previously implicated in autism susceptibility and identifying 20 additional candidate genes, including MYO1E, KCND3, PDCD1, DLX3, and TSPAN4 (false discovery rate < 0.3).

Conclusion

By incorporating functional predictions, VARPRISM improved the statistical power to identify de novo mutations increasing disease risks. VARPRISM is available at http://www.hufflab.org/software/VARPRISM.

Background

De novo mutations contribute substantially to the risk of several genetic diseases, including Autism Spectrum Disorder (ASD) [13], intellectual disability, and schizophrenia [411]. To identify associations between de novo mutations and disease risk, most existing approaches separately consider different class of mutations, for example, loss-of-function mutations [12], missense mutations [12], or mutations predicted to be damaging [13]. The observed number of mutations in a gene is compared to the expected number based on the known mutation rate. A p value is then calculated as the tail-probability of the expected distribution under the null, derived either through Poisson approximations or simulations [12, 14]. This framework, however, suffers from a difficult optimization problem: including too many mutation classes will decrease the signal-to-noise ratio, while including too few may exclude many causal mutations. For example, in a previous report estimating the proportion of missense and likely gene disrupting (LGD) mutations contributing to ASD [12], excluding missense mutations would eliminate 57 % of causal mutations, while including missense mutations would decrease the signal-to-noise ratio from 0.75 to 0.22.

Variant prediction algorithms, such as SIFT [15], Polyphen-2 [16], and MutationTaster [17], assess the potential functional impact of genetic variants on proteins using a variety of information sources, including amino acid substitution (AAS), protein structural information, and phylogenetic conservation. These algorithms are well suited for classification of individual disease-causing variants [16]; however, because classification accuracy rarely exceeds 75 % [18], a binary inclusion-exclusion approach based on the predicted severity of each mutation will exclude many true positives.

To account for uncertainty in variant effect prediction, rare variant association tests such as SKAT [19] and VAAST [20] often use prediction scores as a continuously scaled weight in various forms, e.g. as the variance of the random effect [19] or as the likelihood in the composite likelihood ratio test [20]. A loss-of-function mutation typically receives the highest weight and therefore has the largest influence on the statistical test, while a synonymous mutation often receives a weight of 0. Previously, Jiang et al. [21] developed the fitDNM de novo mutation load test, which incorporates functional predictions from variant classifiers into the de novo mutation load test. fitDNM requires specification of probabilities for any given mutation in the protein being damaging, which can be generated, for example, using PolyPhen-2. Jiang et al. demonstrated that fitDNM has higher statistical power compared to existing methods such as Poisson tests and TADA-denovo [13].

Here we present the VARiant PRIoritization SuM (VARPRISM) software package, which predicts the functional impact of de novo mutations and incorporates these quantitative predictions using a likelihood ratio test to evaluate evidence of de novo mutation load. We compared the power of VARPRISM to fitDNM and Poisson tests with two simulated datasets. We then analyzed 2508 parent-offspring autism trios from the Simons Simplex Collection (SSC) to identify autism candidate genes.

Implementation

Statistical model of VAPRISM

VARPRISM analyzes de novo mutations in the genomes of affected individuals to identify genes with elevated de novo mutation rates of functional protein-coding mutations. Let AAS i j be the random variable vector describing functional consequence of the j-th de novo mutation within the i-th affected individual in the protein of interest. AAS ij includes a categorical variable (the amino acid substitution caused by the mutation, e.g. Leucine to Proline change) and a continuous variable (the PhastCons score at the mutation [22]). We use the random variable M ij to denote the event that the j-th mutation within individual i occurred in the gene of interest. M ij can be partitioned into two disjoint events: (1) a disease-causal mutation occurred (denoted by random variable D ij ); and (2) a neutral mutation occurred (denoted by random variable N ij ). For any observed de novo mutation, indexed by i and j, the joint probability of the M ij and AAS ij is:

$$ \begin{array}{l} \Pr \left({M}_{ij}, AA{S}_{ij}\left|r,m\right.\right)\\ {}= \Pr \left({N}_{ij}, AA{S}_{ij}\left|r,m\right.\right)+ \Pr \left({D}_{ij}, AA{S}_{ij}\left|r,m\right.\right)\\ {}=P\left({N}_{ij}\left|r,m\right.\right) \Pr \left( AA{S}_{ij}\left|{N}_{ij},r,m\right.\right)+P\left({D}_{ij}\left|r,m\right.\right) \Pr \left( AA{S}_{ij}\left|{D}_{ij},r,m\right.\right)\\ {}=P\left({N}_{ij}\left|r,m\right.\right)\left( AA{S}_{ij}\left|{N}_{ij}\right.\right)+P\left({D}_{ij}\left|r,m\right.\right) \Pr \left( AA{S}_{ij}\left|{D}_{ij}\right.\right)\\ {}=m \Pr \left( AA{S}_{ij}\left|{N}_{ij}\right.\right)+rm \Pr \left( AA{S}_{ij}\left|{D}_{ij}\right.\right)\end{array} $$

where m is the risk-neutral mutation rate (per generation per base pair) [23] at the corresponding nucleotide, which we used the average risk-neutral mutation rate in the gene of interest to approximate. r is the relative mutation rate of disease-causing mutations to risk-neutral mutations. The third equality holds because the distribution of AAS ij is independent of the mutation rates conditional on the disease-risk.

For all k i observed mutations in affected individual i, the joint probability is:

$$ \begin{array}{l} \Pr \left({M}_{i\kern.1em \cdotp }, AA{S}_{i\kern.1em \cdotp}\left|r,m\right.\right)\\ {}={\displaystyle \prod_{j=1}^{k_i} \Pr \left({M}_{ij}, AA{S}_{ij}\left|r,m\right.\right)}\\ {}={\displaystyle \prod_{j=1}^{k_i}\left[m \Pr \left( AA{S}_{ij}\left|{N}_{ij}\right.\right)+rm \Pr \left( AA{S}_{ij}\left|{D}_{ij}\right.\right)\right]}.\end{array} $$

The first equality holds under the assumption that de novo mutations occur independently, conditional on the neutral and disease-causal de novo mutation rates. Under the null (r = 0), this assumption is strictly satisfied; under the alternative, this is justified because the mutation rate is sufficiently low to be very unlikely to observe two de novo mutations in the same gene of the same individual.

To account for genomic sites where no de novo mutations occurred in our model, we use G i to denote the genotype of individual i, with the following density function:

$$ \begin{array}{l} \Pr \left({G}_{i\kern.1em \cdotp }, AA{S}_{i\kern.1em \cdotp}\left|r,m\right.\right)\\ {}={\left(1-m-rm\right)}^{n-{k}_i}{\displaystyle \prod_{j=1}^{k_i}\left[m \Pr \left( AA{S}_{ij}\left|{N}_{ij}\right.\right)+rm \Pr \left( AA{S}_{ij}\left|{D}_{ij}\right.\right)\right]}\end{array} $$

where n is 2 times the number of base pairs in the coding sequence of the gene of interest. If we use G and AAS to denote the genotypes and functional impact of amino acid substitutions in all affected individuals and assume independence across individuals, then the following holds:

$$ \begin{array}{l} \Pr \left(\boldsymbol{G},\boldsymbol{A}\boldsymbol{A}\boldsymbol{S}\left|r,m\right.\right)\\ {}={\displaystyle \prod_{i=1}^t\left\{{\left(\mathrm{l}-m-rm\right)}^{n-{k}_i}{\displaystyle \prod_{j=1}^{k_i}\left[m \Pr \left( AA{S}_{ij}\left|{N}_{ij}\right.\right)+rm \Pr \left( AA{S}_{ij}\left|{D}_{ij}\right.\right)\right]}\right\}}\end{array} $$

where t is the number of affected individuals. The parameter m can be estimated either from literature or from the data. The quantity above is equivalently the likelihood of the parameter r (that is, L(r)).

Under the null hypothesis (H0), no de novo mutations within the gene of interest contribute to disease risk. This implies that the probability of having a disease-causal de novo mutation is 0, or formally, Pr(D ij |r,m) = 0 for all values of i and j. Given Pr(D ij |r, m) = rm and m ≠ 0, we have r = 0. Conversely, r = 0 suggests that the relative mutation rate of disease-causing mutations to risk-neutral mutations is 0 (by definition), and therefore no disease-causing de novo mutation can occur. We can apply a likelihood ratio test to calculate the following test statistic:

$$ D=-2\left[ \ln \left( \Pr \left(\boldsymbol{G},\boldsymbol{A}\boldsymbol{A}\boldsymbol{S}\Big|r=0,m\right)\right)-{ \sup}_r\left\{ \ln \Pr \left(\boldsymbol{G},\boldsymbol{A}\boldsymbol{A}\boldsymbol{S}\Big|r,m\right)\right\}\right] $$

To obtain the MLE of r under the alternative model, VARPRISM uses the Newton–Raphson method. Specifically, we first performed the following transformation on the variable r: r = e t. We used the following initial values of t: log(0.01), log(0.1), log(1), log(5), log(10), log(20), and log(100), and performed the maximization procedures on each initial value. Each time, t is iteratively updated with Newton step \( \left({t}^{+}=t-{\left(\frac{d^2 \log \Pr \left(\boldsymbol{G},\boldsymbol{A}\boldsymbol{A}\boldsymbol{S}\Big|t,m\right)}{d{t}^2}\right)}^{-1}\frac{d \log \Pr \left(\boldsymbol{G},\boldsymbol{A}\boldsymbol{A}\boldsymbol{S}\Big|t,m\right)}{dt}\right) \) until the maximal number of iterations (by default 20) were performed. At the end, the t value that generated the maximum log-likelihood was selected to calculate r using r = e t. To calculate the statistical significance of the observed D, VARPRISM uses Monte-Carlo methods to simulate mutations in the gene of interest conditioned on the local mutation rate of the gene. Assuming n 1 out of n 2 total simulations have a value of D no less than the observed D, then the p value is calculated as (n 1  + 1)/(n 2  + 1).

Mutational model

A correct estimation of local mutation rate is essential for robust statistical characterization of genes with disease-causing de novo mutations. To control for heterogeneity in local mutation rates, VARPRISM incorporates the mutation rate estimate reported by Francioli et al. [23]. Specifically, Francioli et al. estimated the empirical distribution of genome-wide mutation rates from 250 parent-offspring families, accounting for flanking sequence context, local mutation rates, mutation type, and the transcribed strand [23]. Based on this estimate and the actual nucleotide sequence, we summed the mutation rates at every base pair of the gene to derive the expected de novo mutation rate (m) for each protein-coding gene. Similarly, we compute the distribution of amino acid substitutions caused by mutations under the null model (Pr(AAS|N)), by considering all possible mutations at each base pair within the exons of the gene. Pr(AAS|N) and m are used in formula (1) and in Monte-Carlo simulations. Under the alternative model, the distribution of amino acid substitutions (Pr(AAS|D)) is estimated by the AAS frequency spectrum observed in the Human Gene Mutation Database (HGMD) [24]. This approach (CASM) was previously used to calculate functional weights of rare variants in gene-based association tests; the details on the training process of CASM were described in the Additional file 1: Supplementary Methods and in our previous publication [18].

Note that the calculation of Pr(AAS|N) is exact assuming the mutation rate reported in [23] is accurate. However, Pr(AAS|D) is often only an approximation, given that the AAS distribution for all possible mutations that could influence the risk of a specific disease within a given gene cannot be known for ab initio risk gene discovery. When Pr(AAS|D) is correctly specified, then the likelihood ratio test statistic is approximately distributed as a 50:50 mixture of two chi-square variables with 0 and 1 degree(s) of freedom, respectively [25]. Otherwise, under the null, the likelihood becomes:

$$ \ln L\left(r=0\right)= \ln \left(\mathrm{l}-m\right){\displaystyle \sum_{i=1}^t\left(n-{k}_i\right)+}{\displaystyle \sum_{i=1}^t{\displaystyle \sum_{j=1}^{k_i} \ln \left[m \Pr \left( AA{S}_{ij}\left|{N}_{ij}\right.\right)\right]}} $$

which does not depend on Pr(AAS|D). Under the alternative, the maximal likelihood is:

$$ \begin{array}{l} \sup \left\{ \ln L(r):r\ge 0\right\}\\ {}= \ln \left(\mathrm{l}-m-\widehat{r}m\right){\displaystyle \sum_{i=1}^t\left(n-{k}_i\right)+{\displaystyle \sum_{i=1}^t{\displaystyle \sum_{j=1}^{k_i} \ln \left[m \Pr \left( AA{S}_{ij}\left|{N}_{ij}\right.\right)+\widehat{r}m \Pr \left( AA{S}_{ij}\left|{D}_{ij}\right.\right)\right]}}}\end{array} $$

which is a function of Pr(AAS|D). In other words, although the null model likelihood is correctly specified, the alternative model likelihood is often not. In this scenario, as Vuong has demonstrated, the likelihood ratio test still applies (theorem 7.2. in [26]), but the distribution of the test statistic becomes a linear combination of χ2 variables whose weights depend on the likelihood in the alternative model. Since Pr(AAS|D) is unknown, by default VARPRISM avoids the analytical approximation for the distribution of the test statistic, instead relying on Monte-Carlo simulations to sample from its null distribution. Because the Monte-Carlo simulations do not use Pr(AAS|D) to generate mutations, a Type I error rate is correctly specified (Table 1).

Table 1 Type I error of VARPRISM in the null simulations (showing 95 % CI in the bracket)

Since the observed de novo mutation rate may depend on factors that differ across studies (for example, paternal age at conception and variant calling procedures), we provided a script to calibrate the genome-wide average de novo mutation rate based on the frequency of de novo mutations in the current dataset. The de novo mutation rate of small insertions and deletions (indels) are estimated separately from SNVs, because the ratio of indel and SNV mutations will likely vary by the sequencing platform and variant calling pipelines [27]. The estimated SNV and indel mutation rates are required parameters in VARPRISM. When indels are not of interest, the indel mutation rate can be set to 0.

The mutation simulation framework in VARPRISM is also implemented into the pVAAST software package v2.2 [28], which can jointly analyze pedigrees with de novo mutations, inherited variants, and variants in sporadic cases. pVAAST incorporates gene-based linkage analysis, case-control association, and variant prediction information to identify genes contributing to disease risk in pedigrees.

Power analyses

Power analyses in Fig. 1 were generated from simulated de novo mutation data. The simulated gene length was 2000 bp with a baseline mutation rate of 1.2 × 10–8 per generation per haploid base pair. The relative causal mutation rates (r in the formula 1) vary from 0 to 19. We generated the number of mutations in each simulation from a Poisson distribution, with the expected mutation count equal to the sum of baseline mutation rate multiplied by (1 + r). To simulate causal mutations, we sampled mutations from either HGMD mutations (excluding mutations used for training VARPRISM) or de novo protein-altering mutations found in ASD cases within genes with false discovery rate (FDR) < 0.01 in [29]. We note that these two sets of mutations (HGMD mutations and ASD de novo mutations from [29]) do not have any overlap. To simulate risk-neutral protein-coding mutations, we sampled mutations from possible protein-coding mutations in the human exome. The probability of sampling was proportional to corresponding mutation rates. For each simulated mutation, the type of nucleotide and amino acid substitution, local mutation rate, Phastcons score [22], and Polyphen-2 score [16] were the same as the source mutation in the exome. All simulations used a sample size of 5000 cases with the exception of the case of r = 0 (null simulation), which used a sample size of 100,000 cases to detect any potential inflation or deflation of type I error. For each r > 0, 1000 repetitions were generated. At r = 0, 10,000 repetitions were generated.

Fig. 1
figure 1

Power comparison between fitDNM, Poisson-all, Poisson-LGD, and VARPRISM. Left: Power benchmark using de novo mutations in ASD risk genes as damaging mutations. Right: Power benchmark using Human Gene Mutation Database (HGMD) variants as damaging mutations. The sample size is 5000 genomes and the number of trials is 1000. We set the statistical significance threshold at 5 × 10–4

To accommodate fitDNM, we created customized scripts to generate necessary input files of fitDNM from simulated data. Since fitDNM currently does not currently support indels, we did not include indels in our simulations.

Results

Overview of VARPRISM

VARPRISM tests the null hypothesis that de novo mutations in a gene are not associated with disease. We derived the log-likelihood of the observed de novo mutations and their corresponding amino acid substitutions (AAS). VARPRISM calculates the AAS likelihoods using a conservation-controlled amino acid substitution matrix (CASM), which was introduced in VAAST 2.0 [18]. CASM is a variant prediction algorithm that incorporates AAS and phylogenetic conservation information and is calibrated using disease mutation databases (Additional file 1: Supplementary Methods). To illustrate the ability of the CASM score to differentiate between benign and disease-causing mutations, we calculated CASM scores for each de novo mutation in 15 previously reported ASD risk genes [30] in an ASD whole-exome sequencing study [29]. For comparison, we randomly generated 1000 single nucleotide de novo mutations in these genes according to the actual genomic sequences and performed the same calculation. The mean CASM score (likelihood of AAS under alternative divided by null) of ASD mutations was 1.83, compared to 1.13 for randomly generated mutations (p = 6.4 × 10–4, Wilcoxon rank sum test).

To conduct a gene-based test of de novo mutation load, VARPRISM estimates the relative mutation rate of disease-causing mutations (r) among individuals with the disease compared to a baseline mutation rate in each gene. Under the null hypothesis that de novo mutations in a gene are not associated with the disease phenotype, r is equal to 0, indicating that the mutation rate among affected individuals is the same as the baseline rate. VARPRISM then calculates the likelihood ratio statistics using the maximum likelihood estimate (MLE) of r and evaluates statistical significance via Monte-Carlo simulations. The details of the statistical model are elaborated in the “Implementation” section.

To control for mutation rate heterogeneity resulting from flanking sequence context, DNA replication start sites, nucleotide composition, etc., VARPRISM incorporates site-specific mutation rate estimates throughout the genome. By default, VARPRISM uses the mutation rate estimates from Francioli et al. [23], although alternative estimates can be provided. The mutation simulation pipeline used by VARPRISM is also implemented in pVAAST v2.2 [28], which can jointly analyze de novo and inherited mutations in pedigrees.

Power in simulations

To evaluate the statistical power of VARPRISM, we simulated mutation data for 5000 parent-offspring trios using mutations from the HGMD [24] or the 13 genes with FDR < 0.01 in [29] based on an excess of de novo mutations identified in ASD cases, varying the relative mutation rate of damaging mutations in the simulated causal gene (see “Implementation”). We calculated power as the proportion of simulations in which we found a significant association (α = 5 × 10–4). For each simulation, we evaluated four tests: VARPRISM, fitDNM, a Poisson test using all non-synonymous mutations (Poisson-all), and a Poisson test using only likely gene-disrupting (nonsense, frameshift, and splice sites) mutations (Poisson-LGD). For fitDNM, we used Polyphen-2 to predict mutation impact as in the original fitDNM article [21] and suggested by the User Manual; however, we also explored using transformed CASM scores (Additional file 1: Supplementary Methods; Figure S1). In both simulations, the statistical power of VARPRISM was consistently higher than the other three tests (Fig. 1). In the HGMD simulation, when VARPRISM achieved 85 % power, the power of the other three methods was 82 %, 70 %, and 25 % for fitDNM, Poisson-all, and Poisson-LGD, respectively. In the ASD simulation, when VARPRISM achieved 86 % power, the power of the other three methods was 84 %, 70 %, and 58 %, for fitDNM, Poisson-all, and Poisson-LGD, respectively. The average damaging mutation rates estimated by VARPRISM closely approximated their simulated values (Additional file 1: Figure S2). The type I error rates of each method are shown in Table 1. For VARPRISM, the observed type I error rate was consistent with the nominal rate at all levels (alpha = 0.05 and 0.01).

VARPRISM analysis of de novo mutations in congenital heart disease

Previously, Zaidi et al. [31] investigated the role of de novo mutations in the etiology of congenital heart disease (CHD) from whole-exome sequencing data on 362 CHD parent-offspring trios with affected probands and unaffected parents. Within probands, they identified eight genes with de novo mutations that are involved in the production, removal, or reading of H3K4 methylation (H3K4me pathway) [31]. The authors also found that the gene SMAD2, a regulator of H3K27 methylation, was mutated twice. VARPRISM identified SMAD2 and all eight genes with nominal significance (p < 0.05). In comparison, Poisson-all, Poisson-LGD, and fitDNM identified six, four, and seven genes, respectively, with nominal significance (Additional file 1: Figure S3). SMAD2 was genome-wide significant (p = 2.1 × 10–6) with VARPRISM but not with Poisson-all (p = 2.3 × 10–5), Poisson-LGD (p = 9.6 × 10–4), or fitDNM (p = 4.6 × 10–6). We also jointly evaluated the association of genes in the H3K4me pathway with CHD by combining p values for each of the four tests from all 30 genes in the H3K4me pathway using Fisher’s method [32]. VARPRISM was the only test that identified a statistically significant enrichment of genes in the H3K4me pathway, with p equal to 0.017 compared to 0.36, 0.95, and 0.18 by Poisson-all, Poisson-LGD and fitDNM, respectively.

VARPRISM analysis of de novo mutations in ASD

The SSC, established by the Simons Foundation Autism Research Initiative (SFARI), is a genetic resource for autism studies that includes samples from thousands of simplex pedigrees with one affected child and unaffected parents and siblings [12, 33, 34]. Previously, Iossifov et al. [12] described results from whole-exome sequencing of 2,508 affected children from the SSC dataset. In this study, they identified 391 de novo LGD mutations in 353 genes, among which 27 target genes contain recurrent LGD mutations. They also identified 2801 missense mutations within 1500 genes, although the original study focused on analyzing LGD mutations [12]. We perform a joint analysis of LGD and missense mutations using VARPRISM, fitDNM, Poisson-all, and Poisson-LGD to identify additional candidate ASD risk genes [12, 33, 34]. Note that the current implementation of fitDNM does not support indels, and thus only single nucleotide variants were included in the fitDNM analysis.

With an FDR of 0.1, VARPRISM identified 19 genes, compared to four by fitDNM, four by Poisson-all, and three by Possion-LGD (Table 2). Of the 19 candidate genes identified by VARPRISM, 17 were in genes previously reported to harbor de novo mutations in ASD cases (Additional file 1: Table S1). With one exception (PTEN), all the candidate genes found by fitDNM, Poisson-all, and Poisson-LGD were identified by VARPRISM. We then tested enrichment among genes in AutDB, which is a large collection of ASD candidate risk genes created by first performing data-mining on published scientific articles and then manually annotating each gene entry by expert biologists [35]. Four types of genes were collected in AutDB: genes implicated in rare monogenic forms of ASD; genes implicated in syndromic forms on autism; genes that carry a relatively small risk for ASD identified in genetic association studies; and genes previously reported to be functionally relevant to ASD biology. Fifteen out of the 19 genes identified by VARPRISM at an FDR of 0.1 were present in AutDB (0.7 expected by chance; p < 2.2 × 10–16), including: DYRK1A, WAC, TBL1XR1, KDM6B, GRIN2B, DSCAM, POGZ, SCN2A, SUV420H1, CHD8, TBR1, KDM5B, KATNAL2, TCF7L2, and CHD2.

Table 2 List of genes identified by VARPRISM, fitDNM, Poisson-all, and Poisson-LGD in the SSC dataset

Due to the sparsity of de novo mutations and the limited statistical power in our dataset, we also explored a more relaxed FDR threshold of 0.3, as applied previously in a recent study of de novo mutations in ASD [29]. VARPRISM identified 64 candidate genes, compared to seven by fitDNM, 10 by Poisson-LGD, and five by Poisson-all (Table 2 and Fig. 2). With an FDR of 0.3, the expected number of true positive ASD risk gene found by VARPRISM was 45, which was 2.6 times higher than the expected number under FDR of 0.1(17). Of the 64 genes identified by VARPRISM, 33 were present in AutDB (2.3 expected by chance; p < 2.2 × 10–16). Thus, the relaxed cutoff increased the proportion of false positive discoveries in our candidate genes, but also substantially improved the power to identify novel ASD risk genes. Excluding genes that were also identified by Poisson tests or fitDNM, 28 of the 47 remaining genes have been previously reported to contain de novo mutations among ASD cases in other datasets. Many of these were repeatedly reported to be associated with ASD, including CTCF, SYNGAP1, SLC6A8, NTNG1, and GLRA2 (Additional file 1: Table S1). Three of the 19 remaining VARPRISM candidate genes without de novo association evidence, MYO1E, KCND3, and PDCD1 are potentially promising candidates, due to their associations with social communication problem (MYO1E) [36], deficits in non-verbal communication (KCND3) [37] and 2q37-deletion syndrome (PDCD1) [38]. Two additional genes with FDR < 0.3, DLX3 and TSPAN4, are involved in mechanisms related to ASD. We described the potential implications of these genes in ASD in more details in the “Discussion” section.

Fig. 2
figure 2

Candidate de novo mutated genes identified by VARPRISM, Poisson tests, and fitDNM. Left, the pie chart shows the relative proportion of genes found by VARPRISM and any other tests (Poisson-all, Poisson-LGD, or fitDNM). Right, the pie chart further illustrates the level of evidence for genes found by VARPRISM only. Gene names in each category were listed below

Over-representation of candidate autism genes in functional gene classes

Iossifov et al. identified six functional gene classes that were significantly overrepresented among their candidate autism genes: fragile X mental retardation protein, chromatin modification, embryonic development, essential genes, schizophrenia de novo mutation, and intellectual disability de novo mutations gene classes [12]. Genes identified by VARPRISM with FDR < 0.3 from SSC were significantly over-represented in each of these six functional gene classes (Fig. 3 and Additional file 1: Table S2). In particular, VARPRISM identified six genes in the intellectual disability gene class, which was a 59.0-fold enrichment relative to expectation (p = 1.1 × 10–9). In comparison, fitDNM, Poisson-all, and Poisson-LGD identified two (p = 5.3 × 10–5), one (p = 7.9 × 10–3), and two (p = 1.1 × 10–4) genes in the intellectual disability gene class, respectively. Similarly, in the fragile X mental retardation protein gene class, VARPRISM identified 17 genes (6.3-fold enrichment; p = 8.5 × 10–10), while fitDNM identified three (p = 2.30 × 10–3), Poisson-all identified three (p = 7.0 × 10–4), and Poisson-LGD identified four (p = 5.4 × 10–4).

Fig. 3
figure 3

Overlap between candidate ASD genes and six functional gene classes. Four methods for identifying candidate genes were compared. The upper plot shows the p-values under the null hypothesis that the candidate ASD gene list is independent from the functional gene classes, calculated using a binomial test; the lower plot shows the actual number of overlapping genes between candidate genes and the functional gene classes

To search for additional functional gene classes involved in ASD, we evaluated the VARPRISM candidate gene list in the Database for Annotation, Visualization and Integrated Discovery (DAVID) (Additional file 1: Table S3). After removing closely related GO terms, the top 3 terms were GO:0016568 (chromatin modification, Benjamini FDR = 9.3 × 10-4), GO:0006325 (chromatin organization, Benjamini FDR = 1.5 × 10-3) and GO:0060070 (Wnt receptor signaling pathway through beta-catenin, Benjamini FDR = 0.047). These findings were in agreement with the autism-related functional pathways identified by Iossifov et al [12] and De Rubeis et al [29].

Discussion

Most existing de novo mutation load tests classify de novo mutation as either damaging or neutral in a dichotomous fashion and include only the putatively damaging mutations in the test [12, 14]. However, many different criteria of choosing damaging mutations exist, for example: (1) protein-coding mutations; (2) mutations predicted as damaging by variant classification software; or (3) loss-of-function mutations. Choosing a more stringent criterion can increase the signal-to-noise ratio of the analyses but carries the risk of missing a true risk gene. Some researchers opt to perform multiple de novo mutation load tests with different classification criteria; doing so, however, increases the burden of multiple-testing correction and can also result in loss-of-power power for causal genes with mutations from multiple risk tiers. For most disease-gene associations, no existing variant classification scheme can generate sufficiently accurate classifications to produce an optimal dichotomous de novo mutation test. For example, we previously reported that SIFT, PolyPhen-2, and MutationTaster correctly predicted disease causing and benign variants only 57 %, 62 %, and 74 % of the time, respectively, on the HGMD and 1000 genomes testing sets [18], which is consistent with findings reported elsewhere [3941]. As a result, dichotomous classification schemes will typically exclude many true disease-causing mutations. An alternative approach, adopted by TADA-denovo [13], is to analyze multiple categories of mutations (e.g. LGD and missense) separately, and then combine the Bayes factor of individual analyses. This method, however, requires classifying mutations into broad categories and cannot readily incorporate functional prediction scores generated by variant classification tools. Indeed, Jiang et al. have previously shown that a de novo mutation test (fitDNM) using continuously scaled functional weight outperforms TADA-denovo in simulations and in neurological-disorder datasets [21].

We have developed an alternative approach, implemented in the software package VARPRISM, which jointly considers the full likelihood of the observed mutations and the predicted impacts on protein function. By default, VARPRISM calculates the CASM score of each mutation to predict potential pathogenicity, although external variant prediction scores from other tools can alternatively be provided on the command line. VARPRISM exhibited increased statistical power for detecting de novo mutation disease risk genes compared to alternative approaches (fitDNM and Poisson tests) in both simulated and real datasets. VARPRISM derives baseline mutation rates under the null model from site-specific mutation rate estimates across the genome. The software defaults to the mutation rate estimates from Francioli et al. [23], but also supports user provided site-specific mutation rate estimates. Thus, VARPRISM is compatible with alternate null models that modify mutation rates under the null model to account for the estimated strength of purifying selection (i.e. level of selective constraint) [14].

VARPRISM shares a few similarities with the fitDNM test. Both tests derived the full likelihood of observed de novo mutations among affected individuals; both also incorporated a functional prediction term for each mutation. However, a few differences exist. First, fitDNM is based on a score test while VARPRISM is based on a likelihood ratio test. Although asymptotically equivalent [42], in practice the performances of these two tests frequently vary [4345]. Second, fitDNM considers the posterior probability of a mutation being damaging as the functional weight (e.g. PolyPhen-2 score), while VARPRISM employs the likelihood ratio of a mutation being damaging versus risk-neutral (e.g. CASM score). Finally, although the fitDNM model can in theory analyze small indels, this functionality is not available in the current implementation, which likely accounts for the differences in performance between fitDNM and VARPRISM in the SSC dataset. For example, among the 64 genes with FDR < 0.3 in VARPRISM, 34 contained at least one de novo indel.

In VARPRISM, the likelihood distribution of AAS caused by damaging mutations was trained using the HGMD. While this distribution may not accurately represent the true AAS distribution for de novo mutations, only the alternative model is potentially affected. Thus, mis-specification of the AAS distribution for damaging mutations will not inflate Type-I error (Table 1; also see “Implementation”), but may compromise power. We explored this possibility by comparing VARPRISM’s power between our HGMD and ASD simulations. In the former dataset, the training and testing mutations were both random disjoint subsets from HGMD, and therefore is the scenario where the AAS distribution used by VARPRISM reflects the true distribution under the alternative model. In the latter dataset, the training set remained the same, but mutations in the testing set were sampled from de novo mutations in known ASD risk genes in cases. Interestingly, despite the mis-specified AAS distribution, the power from the HGMD simulations was consistently 3–5 % lower than in ASD simulations. This unexpected difference in power was the result of underlying differences in the proportion of LGD mutations in each dataset, which was 37 % in ASD and 19 % in HGMD. Because LGD mutations are rare under the null model, a large proportion of LGD mutations under the alternative model increased the signal-to-noise ratio in VARPRISM, resulting in a corresponding increase in statistical power. Given that purifying selection has less of an effect on the distribution of de novo mutations compared to inherited variation, in most disease datasets analyzed by VARPRISM, the proportion of LGD mutations will probably be higher than that of HGMD. Therefore, we expect VARPRISM to exhibit robust performance in the context of mis-specified AAS distributions in most situations.

Our VAPRISM analysis of the SSC dataset identified 64 candidate ASD risk genes (FDR < 0.3) compared to 18 from the union of the other three tests (fitDNM, Poisson-all, and Poisson-LGD). The majority (44 out of 64) of these genes were either annotated by AutDB as candidate risk genes or previously found to contain de novo mutations in ASD cases. Three novel VARPRISM candidate genes, MYO1E (q = 0.21), KCND3 (q = 0.19), and PDCD1 (q = 0.10), were especially promising due to their implications in autistic symptoms in previous association studies. MYO1E encodes a member of the myosin protein family and is involved in intracellular movement and membrane trafficking [46]. In a previous cohort study on UK population-based birth cohort [36], a common variant, rs4218 in MYO1E, was the top genome-wide signal associated with Short Pragmatic Composite Score (SPC), which measures social communication abilities (p = 2.6 × 10–8). Another sequencing study found mutations within the putatively regulatory regions of the MYO1E gene in autism-affected probands [47]. KCND3 encodes potassium channels and functions in creating action potentials [46] and has been significantly associated with Non-Verbal Communication (NVC) score in haplotype-block based association tests of two independent samples [37]. In that study, two haplotype blocks in the introns of KCND3 were significantly associated with NVC with the Family-Based Association Test (p = 0.02 and 0.0006). The third gene, PDCD1, is one of the genes disrupted in 2q37-deletion syndrome. The 2q37 locus is one of the most frequently deleted subtelomric region; the symptoms of its deletion include autistic phenotypes, intellectual disability, and seizures [38].

Two other VARPRISM candidate genes are potentially interesting due to the similarity of their molecular functions to known ASD risk genes. DLX3 (q = 0.29) belongs to the distal-less homeobox gene family, which is essential in regulating forebrain and basal ganglia development [48]. Variants in both DLX1 and DLX2, which are genes homologous to DLX3, increase the risk of ASD in a previous association study. [49] TSPAN4 (q = 0.24) is a member of the tetraspanin family. A missense variant in TSPAN7, a homolog of TSPAN4, is associated with X-linked mental retardation [50]; the same variant was also present in an autistic child in an independent study [51]. These potential associations should be interpreted with caution given the relaxed FDR cutoff.

Conclusion

We presented a new statistical framework and software package, VARPRISM, which incorporates variant prioritization information to identify genes with a statistically significant excess of de novo mutations contributing to genetic diseases. We applied our method to the ASD dataset in Iossifov et al. [12] and identified 64 ASD candidates risk genes with FDR < 0.3, of which 44 have previously been implicated in ASD. Our results demonstrate that incorporating AAS and phylogenetic conservation information into the statistical analyses of de novo mutations can substantially improve the power of disease gene discovery.

Availability and requirements

VARPRISM runs under Linux or OS X environment and requires Perl and CPAN installed. The main input file of VARPRISM is a list of mutations with annotated impacts on the protein function, which can be generated with either VAAST [20] or ANNOVAR [52]. The running time for a genome-wide VARPRISM analysis on a 2500-sample dataset on an Intel Xeon 2.00 GHz CPU was 14.6 h. VARPRISM is available for download at http://www.hufflab.org/software/VARPRISM/.

References

  1. Caronna EB, Milunsky JM, Tager-Flusberg H. Autism spectrum disorders: clinical and research frontiers. Arch Dis Child. 2008;93:518–23.

    Article  CAS  PubMed  Google Scholar 

  2. Rogers SJ. Developmental regression in autism spectrum disorders. Ment Retard Dev Disabil Res Rev. 2004;10:139–43.

    Article  PubMed  Google Scholar 

  3. Jones KB, Cottle K, Bakian A, Farley M, Bilder D, Coon H, et al. A description of medical conditions in adults with autism spectrum disorder: A follow-up of the 1980s Utah/UCLA Autism Epidemiologic Study. Autism. 2016;20:551–61.

    Article  PubMed  Google Scholar 

  4. Veltman JA, Brunner HG. De novo mutations in human genetic disease. Nat Rev Genet. 2012;13:565–75.

    Article  CAS  PubMed  Google Scholar 

  5. Jeste SS, Geschwind DH. Disentangling the heterogeneity of autism spectrum disorder through genetic findings. Nat Rev Neurol. 2014;10:74–81.

    Article  PubMed  PubMed Central  Google Scholar 

  6. Marshall CR, Noor A, Vincent JB, Lionel AC, Feuk L, Skaug J, et al. Structural variation of chromosomes in autism spectrum disorder. Am J Hum Genet. 2008;82:477–88.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  7. Sebat J, Lakshmi B, Malhotra D, Troge J, Lese-Martin C, Walsh T, et al. Strong association of de novo copy number mutations with autism. Science. 2007;316:445–9.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  8. O’Roak BJ, Vives L, Girirajan S, Karakoc E, Krumm N, Coe BP, et al. Sporadic autism exomes reveal a highly interconnected protein network of de novo mutations. Nature. 2012;485:246–50.

    Article  PubMed  PubMed Central  Google Scholar 

  9. Fromer M, Pocklington AJ, Kavanagh DH, Williams HJ, Dwyer S, Gormley P, et al. De novo mutations in schizophrenia implicate synaptic networks. Nature. 2014;506:179–84.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  10. Girard SL, Gauthier J, Noreau A, Xiong L, Zhou S, Jouan L, et al. Increased exonic de novo mutation rate in individuals with schizophrenia. Nat Genet. 2011;43:860–3.

    Article  CAS  PubMed  Google Scholar 

  11. Xu B, Roos JL, Dexheimer P, Boone B, Plummer B, Levy S, et al. Exome sequencing supports a de novo mutational paradigm for schizophrenia. Nat Genet. 2011;43:864–8.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  12. Iossifov I, O’Roak BJ, Sanders SJ, Ronemus M, Krumm N, Levy D, et al. The contribution of de novo coding mutations to autism spectrum disorder. Nature. 2014;515:216–21.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  13. He X, Sanders SJ, Liu L, De Rubeis S, Lim ET, Sutcliffe JS, et al. Integrated model of de novo and inherited genetic variants yields greater power to identify risk genes. PLoS Genet. 2013;9:e1003671.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  14. Samocha KE, Robinson EB, Sanders SJ, Stevens C, Sabo A, McGrath LM, et al. A framework for the interpretation of de novo mutation in human disease. Nat Genet. 2014;46:944–50.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  15. Ng PC, Henikoff S. Predicting deleterious amino acid substitutions. Genome Res. 2001;11:863–74.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  16. Adzhubei IA, Schmidt S, Peshkin L, Ramensky VE, Gerasimova A, Bork P, et al. A method and server for predicting damaging missense mutations. Nat Methods. 2010;7:248–9.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  17. Schwarz JM, Rodelsperger C, Schuelke M, Seelow D. MutationTaster evaluates disease-causing potential of sequence alterations. Nat Methods. 2010;7:575–6.

    Article  CAS  PubMed  Google Scholar 

  18. Hu H, Huff CD, Moore B, Flygare S, Reese MG, Yandell M. VAAST 2.0: Improved variant classification and disease-gene identification using a conservation-controlled amino acid substitution matrix. Genet Epidemiol. 2013;37:622–34.

    Article  PubMed  PubMed Central  Google Scholar 

  19. Wu MC, Lee S, Cai T, Li Y, Boehnke M, Lin X. Rare-variant association testing for sequencing data with the sequence kernel association test. Am J Hum Genet. 2011;89:82–93.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  20. Yandell M, Huff C, Hu H, Singleton M, Moore B, Xing J, et al. A probabilistic disease-gene finder for personal genomes. Genome Res. 2011;21:1529–42.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  21. Jiang Y, Han Y, Petrovski S, Owzar K, Goldstein DB, Allen AS. Incorporating functional information in tests of excess de novo mutational load. Am J Hum Genet. 2015;97:272–83.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  22. Siepel A, Bejerano G, Pedersen JS, Hinrichs AS, Hou M, Rosenbloom K, et al. Evolutionarily conserved elements in vertebrate, insect, worm, and yeast genomes. Genome Res. 2005;15:1034–50.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  23. Francioli LC, Polak PP, Koren A, Menelaou A, Chun S, Renkens I, et al. Genome-wide patterns and properties of de novo mutations in humans. Nat Genet. 2015;47:822–6.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  24. Stenson PD, Mort M, Ball EV, Shaw K, Phillips A, Cooper DN. The Human Gene Mutation Database: building a comprehensive mutation repository for clinical and molecular genetics, diagnostic testing and personalized genomic medicine. Hum Genet. 2014;133:1–9.

    Article  CAS  PubMed  Google Scholar 

  25. Self SG, Liang K-Y. Asymptotic properties of maximum likelihood estimators and likelihood ratio tests under nonstandard conditions. J Am Stat Assoc. 1987;82:605–10.

    Article  Google Scholar 

  26. Vuong QH. Likelihood ratio tests for model selection and non-nested hypotheses. Econometrica. 1989;57:307–33.

    Article  Google Scholar 

  27. Lam HY, Clark MJ, Chen R, Chen R, Natsoulis G, O’Huallachain M, et al. Performance comparison of whole-genome sequencing platforms. Nat Biotechnol. 2012;30:78–82.

    Article  CAS  Google Scholar 

  28. Hu H, Roach JC, Coon H, Guthery SL, Voelkerding KV, Margraf RL, et al. A unified test of linkage analysis and rare-variant association for analysis of pedigree sequence data. Nat Biotechnol. 2014;32:663–9.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  29. De Rubeis S, He X, Goldberg AP, Poultney CS, Samocha K, Cicek AE, et al. Synaptic, transcriptional and chromatin genes disrupted in autism. Nature. 2014;515:209–15.

    Article  PubMed  PubMed Central  Google Scholar 

  30. Betancur C. Etiological heterogeneity in autism spectrum disorders: more than 100 genetic and genomic disorders and still counting. Brain Res. 2011;1380:42–77.

    Article  CAS  PubMed  Google Scholar 

  31. Zaidi S, Choi M, Wakimoto H, Ma L, Jiang J, Overton JD, et al. De novo mutations in histone-modifying genes in congenital heart disease. Nature. 2013;498:220–3.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  32. Fisher RA. Statistical methods for research workers. 13th ed. New York: Hafner; 1958.

    Google Scholar 

  33. Krumm N, Turner TN, Baker C, Vives L, Mohajeri K, Witherspoon K, et al. Excess of rare, inherited truncating mutations in autism. Nat Genet. 2015;47:582–8.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  34. Iossifov I, Ronemus M, Levy D, Wang Z, Hakker I, Rosenbaum J, et al. De novo gene disruptions in children on the autistic spectrum. Neuron. 2012;74:285–99.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  35. Basu SN, Kollu R, Banerjee-Basu S. AutDB: a gene reference resource for autism research. Nucleic Acids Res. 2009;37:D832–6.

    Article  CAS  PubMed  Google Scholar 

  36. St Pourcain B, Whitehouse AJ, Ang WQ, Warrington NM, Glessner JT, Wang K, et al. Common variation contributes to the genetic architecture of social communication traits. Mol Autism. 2013;4:34.

    Article  PubMed  PubMed Central  Google Scholar 

  37. Lu AT, Yoon J, Geschwind DH, Cantor RM. QTL replication and targeted association highlight the nerve growth factor gene for nonverbal communication deficits in autism spectrum disorders. Mol Psychiatry. 2013;18:226–35.

    Article  CAS  PubMed  Google Scholar 

  38. Leroy C, Landais E, Briault S, David A, Tassy O, Gruchy N, et al. The 2q37-deletion syndrome: an update of the clinical spectrum including overweight, brachydactyly and behavioural features in 14 new patients. Eur J Hum Genet. 2013;21:602–12.

    Article  CAS  PubMed  Google Scholar 

  39. Flanagan SE, Patch AM, Ellard S. Using SIFT and PolyPhen to predict loss-of-function and gain-of-function mutations. Genet Test Mol Biomarkers. 2010;14:533–7.

    Article  CAS  PubMed  Google Scholar 

  40. Martelotto LG, Ng CK, De Filippo MR, Zhang Y, Piscuoglio S, Lim RS, et al. Benchmarking mutation effect prediction algorithms using functionally validated cancer-related missense mutations. Genome Biol. 2014;15:484.

    Article  PubMed  PubMed Central  Google Scholar 

  41. Walters-Sen LC, Hashimoto S, Thrush DL, Reshmi S, Gastier-Foster JM, Astbury C, et al. Variability in pathogenicity prediction programs: impact on clinical diagnostics. Mol Genet Genomic Med. 2015;3:99–110.

    Article  PubMed  Google Scholar 

  42. Engle RF. Wald, likelihood ratio, and Lagrange multiplier tests in econometrics. Handb Econ. 1984;2:775–826.

    Google Scholar 

  43. Yi Y, Wang X. Comparison of Wald, score, and likelihood ratio tests for response adaptive designs. J Stat Theory Appl. 2011;10:553–70.

    Google Scholar 

  44. Wang K. Statistical tests of genetic association for case–control study designs. Biostatistics. 2012;13:724–33.

    Article  PubMed  Google Scholar 

  45. Agresti A. An introduction to categorical data analysis. New York: Wiley; 1996.

    Google Scholar 

  46. Pruitt KD, Brown GR, Hiatt SM, Thibaud-Nissen F, Astashyn A, Ermolaeva O, et al. RefSeq: an update on mammalian reference sequences. Nucleic Acids Res. 2014;42:D756–63.

    Article  CAS  PubMed  Google Scholar 

  47. Turner TN, Hormozdiari F, Duyzend MH, McClymont SA, Hook PW, Iossifov I, et al. Genome sequencing of autism-affected families reveals disruption of putative noncoding regulatory DNA. Am J Hum Genet. 2016;98:58–74.

    Article  CAS  PubMed  Google Scholar 

  48. Chang SC, Pauls DL, Lange C, Sasanfar R, Santangelo SL. Common genetic variation in the GAD1 gene and the entire family of DLX homeobox genes and autism spectrum disorders. Am J Med Genet B Neuropsychiatr Genet. 2011;156:233–9.

    Article  PubMed  Google Scholar 

  49. Liu X, Novosedlik N, Wang A, Hudson ML, Cohen IL, Chudley AE, et al. The DLX1and DLX2 genes and susceptibility to autism spectrum disorders. Eur J Hum Genet. 2009;17:228–35.

    Article  CAS  PubMed  Google Scholar 

  50. Maranduba CM, Sa Moreira E, Muller Orabona G, Pavanello RC, Vianna-Morgante AM, Passos-Bueno MR. Does the P172H mutation at the TM4SF2 gene cause X-linked mental retardation? Am J Med Genet A. 2004;124A:413–5.

    Article  PubMed  Google Scholar 

  51. Piton A, Gauthier J, Hamdan FF, Lafreniere RG, Yang Y, Henrion E, et al. Systematic resequencing of X-chromosome synaptic genes in autism spectrum disorder and schizophrenia. Mol Psychiatry. 2011;16:867–80.

    Article  CAS  PubMed  Google Scholar 

  52. Wang K, Li M, Hakonarson H. ANNOVAR: functional annotation of genetic variants from high-throughput sequencing data. Nucleic Acids Res. 2010;38:e164.

    Article  PubMed  PubMed Central  Google Scholar 

Download references

Funding

This work was supported by US National Institutes of Health grant R01 GM104390 and Pediatric Cardiac Genomics Consortium grant 1UM1HL128711. H.C. was supported by NIH R01 MH094400. H.H. was supported by University of Texas MD Anderson Odyssey fellowship.

Authors’ contributions

CDH conceived the project and oversaw the research. HH and CDH designed the algorithms and contributed to the statistical development. HH wrote the software. HH and ML performed the experiments. CDH, HH, HC, and MY interpreted the data. HH, CDH, and HC wrote the paper. All authors read and approved the final manuscript.

Competing interests

The authors declare that they have no competing interests.

Consent for publication

Not applicable.

Ethics approval and consent to participate

No ethical approval was required for this study.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Chad D. Huff.

Additional file

Additional file 1:

Contains: Supplementary Methods, Tables S1–S3, and Figures S1–S3. (DOCX 389 kb)

Rights and permissions

Open Access This article is distributed under the terms of the Creative Commons Attribution 4.0 International License (http://creativecommons.org/licenses/by/4.0/), which permits unrestricted use, distribution, and reproduction in any medium, provided you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons license, and indicate if changes were made. The Creative Commons Public Domain Dedication waiver (http://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Hu, H., Coon, H., Li, M. et al. VARPRISM: incorporating variant prioritization in tests of de novo mutation association. Genome Med 8, 91 (2016). https://doi.org/10.1186/s13073-016-0341-9

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s13073-016-0341-9

Keywords