Abstract

Motivation

Classical methods of comparing the accuracies of variant calling pipelines are based on truth sets of variants whose genotypes are previously determined with high confidence. An alternative way of performing benchmarking is based on Mendelian constraints between related individuals. Statistical analysis of Mendelian violations can provide truth set-independent benchmarking information, and enable benchmarking less-studied variants and diverse populations.

Results

We introduce a statistical mixture model for comparing two variant calling pipelines from genotype data they produce after running on individual members of a trio. We determine the accuracy of our model by comparing the precision and recall of GATK Unified Genotyper and Haplotype Caller on the high-confidence SNPs of the NIST Ashkenazim trio and the two independent Platinum Genome trios. We show that our method is able to estimate differential precision and recall between the two pipelines with 103 uncertainty.

Availability and implementation

The Python library geck, and usage examples are available at the following URL: https://github.com/sbg/geck, under the GNU General Public License v3.

Supplementary information

Supplementary data are available at Bioinformatics online.

1 Introduction

Next-generation sequencing (NGS) has enabled entire human genomes to be sequenced in a single experiment and has, since its development, played a crucial role in many areas including population genetics (Auton et al., 2015; Mallick et al., 2016), disease genetics (Bamshad et al., 2011) and the study of human mutations (Veltman and Brunner, 2012). Many variant callers have been developed to call genetic variants from NGS data (Sandmann et al., 2017), employing multiple steps of data processing and statistical inference (Li, 2011). Due to their wide impact, benchmarking variant calling pipelines is of utmost importance (Li, 2014; Shringarpure et al., 2015).

A widely-used method of measuring the accuracy of variant calling pipelines is tallying mis-called variants on samples that have been characterized previously (Cornish and Guda, 2015; Hwang et al., 2015; Olson et al., 2015). High-confidence variant sets, or ‘truth sets’, are compiled by teams of experts, such as the Genome in a Bottle (GIAB) Consortium, by integrating variant calls from several sequencing and data processing technologies. Due to careful curation, these datasets reach very high fidelity and provide a benchmarking reference for SNPs, indels (Boutros et al., 2014; Talwalkar et al., 2014; Zook et al., 2014) and structural variants (Fang et al., 2016; Human Genome Structural Variant Consortium, 2017; Nutsua et al., 2015; Parikh et al., 2016). In all cases, high-coverage sequencing data from a handful of (often related) individuals are required to produce a truth set (Eberle et al., 2017; Zook et al., 2016). Such truth sets are expensive to create, specific to the population and biased toward the methods that produced them.

Sequencing data from related individuals provide an alternative way to detect errors made by a variant calling pipeline. Since de-novo mutation rates [108 per locus (Veltman and Brunner, 2012)] are several orders of magnitude smaller than calling and genotyping error rates (often 102105), one can use the variant calls inconsistent with the rules of Mendelian inheritance to assess genotyping errors. While not all errors result in a Mendelian violation, which limits the sensitivity of this strategy, as noted by Li (2014), additional assumptions about the error probabilities permit the estimation of genotyping error rates from parent-offspring dyads (Haaland and Skaug, 2013), siblings (Johnson and Haydon, 2007; Korostishevsky et al., 2009; Wang, 2004), trios (Douglas et al., 2002; Jostins, 2011; Saunders et al., 2007; Sobel et al., 2002) and larger pedigrees (Eberle et al., 2017). If sequencing reads from many related individuals are available, recombination events can be inferred and used to estimate locus-specific genotyping errors (Chen et al., 2013; Kojima et al., 2013; Markus et al., 2011; Peng et al., 2013). All these approaches have the advantage of not relying on a truth set, thereby eliminating the bias towards established variant callers.

When modeling genotyping calling errors in related individuals, one is tempted to parametrize the genotyping error profile with a couple of parameters and estimate their values independently for different variant callers. This method has two significant shortcomings by neglecting the following correlations: First, errors made by different variant calling pipelines are often correlated due to identical assumptions (e.g. well-mapped reads) which, if violated in the input data, make mistakes of the pipelines coincide at particular loci. Second, mapping and calling errors depend on sequence context, which is similar among closely related individuals and induces correlations between genotyping errors in samples of different family members. To the extent of our knowledge, there exists no published method that addresses both correlations.

Here, we present a statistical model that addresses both shortcomings for the case of a family trio. First, we aggregate the number of different genotype trios for the two pipelines jointly, and model this data. This way, we take correlations between two variant callers explicitly into account. Second, our model consists of a statistical mixture of different genotyping error profiles. Although each error profile assumes independence between family members, enabling an efficient mathematical solution, their mixture captures the correlations.

We validate our model in a series of experiments on real trios. First, we run two variant caller pipelines on publicly available NGS data from trios, and let our model estimate the precision and recall of the two pipelines. Then we compare these estimated performance metrics with their true values. The truth is directly calculated by comparing the calls on the children with their correct genotypes from the truth datasets. We demonstrate that our model is able to detect differential performance (absolute difference of precision or recall) between two pipelines as small as 103. With this level of accuracy, our model enables informed development of pipelines targeting less-studied variants and populations for which no curated truth set is available.

The rest of the paper is divided into three parts: In Section 2, we introduce our notation, describe the structure and assumptions of our model and show how one can use it to infer the number of genotyping errors and stratify them by type. In Section 3, we describe how we validate our method on publicly available trio data. Finally, in Section 4, we present the results of the validation experiment.

2 Model

2.1 Definitions and notation

Trio genotypes. Let I={00,01,11} denote the set of individual, bi-allelic, unphased genotypes: homozygous reference (00), heterozygous (01) and homozygous alternate (11). Let g={gpI:p=1,2,3} be an ordered trio of individual genotypes, representing the genotypes of variants in the genomes of father (g1), mother (g2) and child (g3). Let T denote the set of mathematically possible genotype trios, i.e. T=I×3, and let tT denote its subset that conforms with Mendelian inheritance, i.e. t={gT:(g3,1g1 and g3,2g2) or (g3,1g2 and g3,2g1)}, where g3,1 and g3,2 are the first and second symbols (0 or 1) of g3. One can show that |T|=33=27 and |t|=15 by enumeration.

Observed genotypes. Two variant calling pipelines run independently on samples from the three family members produce six separate sets of variant calls. We require that variant representations are harmonized, after which we can aggregate the counts of different genotype trio pairs of one class of variants (e.g. SNPs, short indels, structural variants) called by the two pipelines across all loci. This yields the joint counts of genotype trios N={NG1,G2:G1,G2T}, where NG1,G2 is the number of variants whose trio genotypes are called G1 by pipeline 1, and G2 by pipeline 2. An example is shown in Figure 1.

Fig. 1.

An example of the joint counts of observed trio genotypes N. Each cell at row G1 and column G2 counts the number of variants for which pipeline 1 calls G1 and pipeline 2 calls G2 trio genotypes. The 27 trio genotypes (T) are sorted such that the first 15 comply with Mendelian inheritance (t). Most variants populate the main diagonal, indicating strong correlation between the pipelines. If the pipelines could exploit that the three individuals form a trio, none of them would call invalid trios and only the upper left corner of the matrix would contain counts. Still some of the counts would be placed off the main diagonal, because the pipelines would not always agree

Correct genotypes. Explicit information about the correct trio genotypes gt is missing from the observed counts N. Let N={NG1,G2,g:G1,G2T,gt} denote the (hidden) complete distribution of called and correct genotype trios, where NG1,G2,g is the number of variants with called genotype trios G1,G2 and correct genotype trio g, such that gNG1,G2,g=NG1,G2,G1,G2. In the next section, we explicitly model the genotyping errors in order to infer the hidden components in N, examples of which are shown in Supplementary Figures S3–S5. Uncovering this data, N, from the observed mixture, N, is our main goal.

Benchmarking metrics. If obtained, the complete distribution N contains all necessary information to directly evaluate any benchmarking metric. We will use the notation μ(·):Nμ to denote any benchmarking metric, derivable from N. One important metric is the genotype confusion matrix, n(p)={ni,j,k(p):i,j,kI}, for individual p, where
ni,j,k(p)=G1,G2,g[i=gp][j=Gp1][k=Gp2]NG1,G2,g,
(1)
where [x = y] is 1, if x = y and 0 otherwise. ni,j,k(p) counts how many variants of person p, with correct genotype iI, are called jI by pipeline 1 and kI by pipeline 2.

Genotyping can be understood as a classification task with one negative (00) and two positive classes (01 and 11). For person p, we define the true positive, false negative, false positive and ‘mixed-up positive’ counts for pipeline 1 as TP1(p)=n01,01,(p)+n11,11,(p), FN1(p)=n01,00,(p)+n11,00,(p), FP1(p)=n00,01,(p)+n00,11,(p) and MP1(p)=n01,11,(p)+n11,01,(p), respectively, where denotes summation over the third index. For pipeline 2, similar formulas apply where the summations are prescribed for the second index. We define precision and recall with the usual formulas: prec=TP/(TP+FP+MP) and rec=TP/(TP+FN+MP), for each person and each pipeline.

2.2 Generative model

We introduce a generative model in a form of a mixture of categorical distributions over (G1,G2)T×T pairs, where each mixture component is labeled by a correct trio genotype gt, and an error category m (defined in this section). The graphical representation of this model is shown in Figure 2. We define the parameters f,θ,E below.

Fig. 2.

Graphical representation of the model. (a) Parameters, f, θ, E, determine the distributions of hidden variables: correct genotype trio g and error category m, and the observed genotype trios: G1 and G2. (b) Transitions from correct genotype trio g to observed genotype trios (G1,G2) are caused by genotyping errors. The correct genotype iI of a variant in the genome of each family member undergoes a transition, subject to the same error category m, resulting in called genotypes (j,k)I×I

Correct frequencies. Let f={fg:gt} denote the frequencies of each correct genotype trio g among the variants under investigation, i.e.
P(g)=fg,
(2)
where f is subject to normalization, i.e. gfg=1. By treating all 15 components of f as independent parameters, our model is able to fit aggregate data of variants not showing Hardy–Weinberg equilibrium [a limitation of the models used by Douglas et al. (2002) and Haaland and Skaug (2013)]. This way of parameterizing the correct frequencies makes our model more flexible than previous approaches that assume global allele frequencies (Browning and Browning, 2013; Douglas et al., 2002; Haaland and Skaug, 2013; Johnson and Haydon, 2007; Korostishevsky et al., 2009; Saunders et al., 2007; Wang, 2004). Supplementary Material E contains more discussion.
Error categories. We assume that each variant is affected by one of the error categories M={a,b,c,d,e}: (a) Both pipelines are correct, (b) Pipeline 1 is correct, (c) Pipeline 2 is correct, (d) Pipelines agree (but not necessarily correct) and (e) Unrestricted joint distribution. Let θ={θg,m:gt,mM} denote the fractions of variants, with correct genotype trio g, that are affected by error category m, i.e.
P(m|g)=θg,m,
(3)
where θ is subject to normalization, i.e. mθg,m=1,g. The error category m is assumed to be the same for all three genomes at a given locus. Now, we extend the definition of N with this additional index, N={NG1,G2,g,m:G1,G2T,gt,mM}, where mNG1,G2,g,m=NG1,G2,g. The idea of alternative error categories is used in Heid et al. (2008) and Korostishevsky et al. (2009), but none considered a mixture over error categories.
Error rates. Let E={Ei,j,k(g,m):gt,mM,i,j,kI} denote the probabilities of calling the genotypes (j, k), when the correct genotype is i for a variant whose correct genotype trio is g and is subject to error category m. Under a given g and m, we assume that errors happen independently and with the same rate, for all members of the trio. In practice, this requires that the samples are prepared, sequenced and analyzed in the same way, separately from each other. This allows us to write the probability of each type of genotyping event gm(G1,G2) as the product
P(G1,G2|g,m)=pP(Gp1,Gp2|g,m)=pEgp,G1p,G2p(g,m),
(4)
where E is subject to the normalization j,kEi,j,k(g,m)=1,g,m,i. Different error categories mM allow only certain components of E to be non-zero:
Ei,j,k(g,m)0, only if{m=a and j=i and k=i(both are correct)m=b and j=i(pipeline 1 is correct)m=c and k=i(pipeline 2 is correct)m=d and j=k(pipelines agree)m=e(unrestricted)
Previously published models either assume an error rate independent of the correct genotype (Browning and Browning, 2013; Jostins, 2011; Saunders et al., 2007; Sobel et al., 2002) or model the E matrix with a few parameters (Douglas et al., 2002; Heid et al., 2008; Johnson and Haydon, 2007; Korostishevsky et al., 2009; Wang, 2004). It is worth emphasizing that we only assume conditional independence of the errors in different family members (conditioned on fixed g and m). The marginal probability P(G1,G2)=g,mP(G1,G2,g,m) does not factorize under our assumptions, enabling our model to capture correlated errors across family members.

2.3 Limiting complexity

The model described so far has 480 algebraically independent parameters (Supplementary Material A.1.1), which is comparable to 27 × 27 = 729, the number of entries in the input data N. To improve the stability of our estimates, we lower the complexity of the model in two ways: limiting the range of error rates, and using parameter sharing.

Limiting error rates. We limit the error rates by requiring that maxj,k(Ei,j,k(g,m))=Ei,i,i(g,m)i,g,m. This guarantees that the largest fraction of the calls (j, k) are indeed correct (=i), separately for each error category.

Parameter sharing. We partition t into three disjunct subsets t=t0t1t2, where t0={(00,00,00)},t2={(11,11,11)} and t1=t(t0t2), and require, whenever both g,g are in t1, that θg,m=θg,m and Ei,j,k(g,m)=Ei,j,k(g,m)m,i,j,k. We choose this partitioning expecting that variants that are present in none (t0) or all (t2) of the genomes will be subject to different error rates than variants for which at least one family member is heterozygous (t1). These constraints allow us to introduce the notation θs,m:=θg,m and Ei,j,k(s,m):=Ei,j,k(g,m) for all gts where s = 0, 1, 2, and reduce the number of algebraically independent parameters to 96. (Supplementary Material A.1.2)

2.4 Inference

Hidden components. The product of Equations (2), (3) and (4) yields the joint distribution of observed (G1,G2) and hidden (g, m) variables,
PG1,G2,g,m=fgθg,mpEgp,Gp1,Gp2(g,m).
(5)
Under the assumption that the attributes (G1,G2,g,m) of different variants are independent and identically distributed (given f,θ,E), one can write the full and conditional distributions of the complete distribution N as (Supplementary Material A.2)
P(N|f,θ,E)=Mult(N|Ntotal,P),
(6)
P(N|N,f,θ,E)=G1,G2Mult(NG1,G2,:,:|NG1,G2,RG1,G2,:,:),
(7)
where Ntotal is the total number of variants (both in N and N), NG1,G2,:,: is a shorthand for {NG1,G2,g,m:gt,mM},P={PG1,G2,g,m},RG1,G2,:,:={RG1,G2,g,m:gt,mM} where RG1,G2,g,m=PG1,G2,g,m/g,mPG1,G2,g,m and Mult({nξ}|ntot,{pξ})=ntot!ξ(pξ)nξ/nξ! is the multinomial distribution. The distribution in Equation (6) describes an unconstrained sampling process where the variants can be freely distributed between bins with different (G1,G2,g,m) labels. The distribution of Equation (7) represents a constrained sampling process where the number of variants in each observable bin (G1,G2) are fixed to the actually observed value NG1,G2, and only their hidden attributes (g, m) are subject to random sampling.
Model parameters. Using Bayes theorem, the conditional posterior of (f,θ,E) can be written as a product
P(f,θ,E|N)P(N|f,θ,E)P(f,θ,E),
(8)
where the last term stands for the prior of the model parameters. Since P(N|f,θ,E) depends only on products of the model parameters [via Equations (5) and (6)], using a product of Dirichlet distributions as prior for (f,θ,E),
P(f,θ,E)=P(f|α(0))P(θ|β(0))P(E|γ(0)),
(9)
yields a posterior with identical structure (Supplementary Material A.3),
P(f,θ,E|N)=P(f|α)P(θ|β)P(E|γ),
(10)
where, in Equations (9) and (10),
P(f|α)=Dir(f|α)
(11)
P(θ|β)=sDir(θs,:|βs,:)
(12)
P(E|γ)=s,m,iDir(Ei,:,:(s,m)|γs,m,i,:,:)
(13)
Here, Dir stands for the Dirichlet distribution, Dir(x|α)=Γ(ξαξ)ξ(xξ)(αξ1)/Γ(αξ), and its parameters are α={αg:gt}, β={βs,m:s{0,1,2},mM}, γ={γs,m,i,j,k:s{0,1,2},mM,i,j,kI}. In Supplementary Material A.3, we show that the posterior values of α, β, γ are
αg=αg(0)+G1,G2,mNG1,G2,g,m
(14)
βs,m=βs,m(0)+G1,G2,g[gts]NG1,G2,g,m
(15)
γs,m,i,j,k=γs,m,i,j,k(0)+G1,G2,g[gts]p[i=gp][j=Gp1][k=Gp2]NG1,G2,g,m
(16)
where [·] evaluates to 1 if the statement inside is true, and 0 otherwise.

Gibbs sampling. The conditional posterior of N [Equation (7)] and f,θ,E [Equation (10)] are products of multinomial and Dirichlet distributions, respectively, both of which can be efficiently sampled. This enables Gibbs sampling, where we start with an initial guess (f,θ,E)(τ=0). In Step 1, we sample the independent multinomials of Equation (7) and obtain the τth sample of the hidden components, N(τ). Then, in Step 2, we sample the independent Dirichlet variables of Equation (10) and obtain the next sample of the model parameters, (f,θ,E)(τ+1). We make sure that maxj,k(Ei,j,k(g,m))=Ei,i,i(g,m) by first sampling each slice Ei,:,:(g,m) from an unconstrained Dirichlet distribution, followed by lowering all components that violate this criteria to the level of Ei,i,i(g,m), and re-normalizing. Repeating Steps 1 and 2 yields approximate samples from the joint posterior P(N,f,θ,E|N). With appropriate ‘burn-in’ (τ0) and ‘thinning’ (Δτ), this procedure provides estimates of the hidden components in the form of a list of samples {N(τ0+lΔτ):l=0,1,2,}. Details of choosing τ0 and Δτ are given in Supplementary Material B.

Benchmarking metrics. From the samples {N(τ)}, the τth estimate of any metric μ can be directly calculated, μ(τ):=μ(N(τ)), enabling accurate estimation of its posterior.

3 Materials and methods

To assess the accuracy of our model, we carried out the validation experiment shown on Figure 3. First, we selected trios for which not only the NGS reads but also curated truth-sets of the children are published, and used two variant caller pipelines to produce variant calls from the read data. Second, we simultaneously used our model to estimate benchmarking metrics for both pipelines on all three members of the trio, and used the correct genotypes from the child’s truth set to calculate the true values of the same benchmarking metrics. Finally, we compared the estimated metrics with the true metrics to calculate the accuracy of our model.

Fig. 3.

Validation experiment. We create two sets of trio variants called by a pipeline using GATK Haplotype Caller and another using GATK Unified Genotyper. Running our trio-based benchmarking model on this data produces estimates of various benchmarking metrics for both pipelines on all three datasets. At the same time, we use the correct genotypes for the child’s truth set to calculate the true values of the same benchmarking metrics. Gray shading marks the components that would be present even in a regular usage of our model, when the truth set is not available

3.1 Data

Read data. We used 50x, 148-bp-long, paired-end, Illumina reads from three trios: the GIAB Ashkenazim trio (ftp://ftp-trace.ncbi.nlm.nih.gov/giab/ftp/data/AshkenazimTrio/; HG003, HG004, HG002), published by the GIAB Consortium (Zook et al., 2016) and 101-bp-long, paired-end, Illumina reads from the two unrelated trios from Platinum Genome (ftp://ftp.sra.ebi.ac.uk/vol1/ERA172/ERA172924/bam/; NA12889, NA12890, NA12877) and (NA12891, NA12892, NA12878), published by Illumina, Inc. (Eberle et al., 2017). From these alignment files, we extracted and sorted the reads using samtools (https://github.com/samtools/samtools) and dropped duplicates and unpaired reads, using a custom script. Command lines are listed in Supplementary Material D.

Truth set for child. Curated, high-confidence variants are publicly available for all three children, HG002 (ftp://ftp-trace.ncbi.nlm.nih.gov/giab/ftp/release/AshkenazimTrio/ (v3.3.2)), NA12877 and NA12878 (ftp://platgene_ro@ussd-ftp.illumina.com/2016-1.0/hg19/). We used bcftools (http://samtools.github.io/bcftools/) to select bi-allelic SNPs on chromosomes 1–22 (4 million). Merging and comparing with the variants produced by the variant caller pipelines allows direct, ‘truth set-based’, benchmarking of the pipelines. (See Supplementary Material D for command lines.) We restricted the scope of our validation experiment to SNPs to avoid having to reconcile different representations of identical variants, which often arise for indels. Supplementary Material C.4 and C.5 contain validation results where we further excluded SNPs near indels, and where we included only SNPs outside of high-confidence regions, respectively.

Pipelines. We used two variant caller pipelines, both of which use BWA-MEM 0.7.13 (Li and Durbin, 2009) for alignment, GATK tools (McKenna et al., 2010) for local realignement and base quality recalibration and take advantage of known SNPs and indels (HapMap, dbSNP, 1000GP, Omni) according to GATK Best Practices recommendations (DePristo et al., 2011; Van der Auwera et al., 2013). In the variant calling step, one pipeline used GATK HaplotypeCaller v3.5, and the other GATK UnifiedGenotyper v2.7. Command lines are listed in Supplementary Material D. (Additionally, Supplementary Material C.6 shows results of comparing pipelines with different aligners).

Aggregating genotype calls. For each trio, we merged the SNPs called by the two pipelines using bcftools, and filtered out the variants that fell outside the high-confidence regions or become multi-allelic. We aggregated the remaining SNPs (4 million) by counting the occurrences of each (G1,G2) combinations, where the trio genotype G1 is called by Haplotype Caller and G2 by Unified Genotyper. During aggregation, we recorded missing variants as genotype 00 and disregarded phasing information, i.e. regarded both heterozygous genotypes, 0|1 and 1|0, as 01. This yielded the observed counts of joint trio calls N={NG1,G2}.

Sub-sampling. To test the robustness of our model, we repeated the validation experiments for subsets of SNPs of different sizes. We sub-sampled a pre-defined number of variants from N by choosing a random subset of SNPs with uniform probability.

3.2 Running the estimator

Imputing ‘uncalled variants’. Neither Haplotype Caller nor Unified Genotyper reports homozygous reference genotypes (i.e. 00) when run on a single sample. Due to this limitation, the number of potential variants that do not get called 01 or 11 by either pipeline in any family member, i.e. N(00,00,00),(00,00,00), is technically zero. With this ‘bulk’ of the 00 genotypes missing, we would not find the correct 0001 and 0011 error rates. To fix this, we used an estimate of the total number of polymorphic loci: the total number of variants reported in dbSNP (https://www.ncbi.nlm.nih.gov/projects/SNP/) (5.2×107).

Details of Gibbs sampling. For each set of input data N, we perform Gibbs sampling as described in Section 2.4. We set the parameters of the Dirichlet priors to αg(0)=1g, βs,m(0)=1s,m and γs,m,i,j,k(0)=1000, if i = j = k and 1 otherwise s,m,i. The skewed choice for γ(0) represents our expectation that the error rates are small (103). We draw the initial values of f,θ,E from their prior, and let the Gibbs sampler run for τ0= 50 000 iterations, allowing it to reach equilibrium. We proceeded by running 100 000 iterations, while recording samples with Δτ=1000 period, to decrease the correlation between consecutive samples. This procedure resulted in 100 samples, {N(τ)}, drawn from its posterior P(N|N). With our scipy-based Python implementation, this procedure takes 4.5 h, using 1 CPU on the AWS instance m1.small.

3.3 Metrics

For each trio, we run the trio-based benchmarking, which produces samples {N(τ)}. From this, we directly calculate the samples of the confusion matrix for the child {n(child)(τ)} [from Equation (1)]. Using the formulas for precision and recall, we obtain their samples {prec(τ)} and {rec(τ)}, for both pipelines. We estimate each metric with the average of its samples.

To investigate how sensitive our model is to the total number of variants, we repeatedly sub-sample the observed counts N, and run the trio-based benchmarking all over again. We do this for 8 different number of variants (1033×106), repeating each sub-sampling and estimation 10 times for every trio.

4 Results

The simplest method of analyzing trio results from the two pipelines is counting Mendelian violations. This, alongside with the true genotyping errors in the child, is shown in Table 1. Comparing the two columns shows that the difference in the number of Mendelian violations correctly indicates the difference in the actual number of genotyping error between the two pipelines.

Table 1.

Number of genotyping errors in the children’s genomes, calculated from comparisons with the truth sets and the number of Mendelian violations in their respective trios

Genotyping errors in child
Mendelian violations in trio
HCUGHCUG
HG002a749620 14239467601
NA12877b36 75939 78057 17959 038
NA12878b34 43637 22411 87514 286
Genotyping errors in child
Mendelian violations in trio
HCUGHCUG
HG002a749620 14239467601
NA12877b36 75939 78057 17959 038
NA12878b34 43637 22411 87514 286

Note: Counts are shown for Haplotype Caller and Unified Genotyper.

With aGIAB (HG002), and bPlatinum Genomes truth VCF and BED files.

Table 1.

Number of genotyping errors in the children’s genomes, calculated from comparisons with the truth sets and the number of Mendelian violations in their respective trios

Genotyping errors in child
Mendelian violations in trio
HCUGHCUG
HG002a749620 14239467601
NA12877b36 75939 78057 17959 038
NA12878b34 43637 22411 87514 286
Genotyping errors in child
Mendelian violations in trio
HCUGHCUG
HG002a749620 14239467601
NA12877b36 75939 78057 17959 038
NA12878b34 43637 22411 87514 286

Note: Counts are shown for Haplotype Caller and Unified Genotyper.

With aGIAB (HG002), and bPlatinum Genomes truth VCF and BED files.

To see how accurately our trio-based benchmarking method can compare the two pipelines, we compare estimates of precision and recall with their true values for the children in Table 2. Although the estimated values of the metrics significantly differ from the truth, both the signs and magnitudes of differential metrics are accurately estimated. This is also visible from the smaller estimation uncertainty σtrio, reported by the model.

Table 2.

Precision and recall of the two pipeline (HC: Haplotype Caller, UG: Unified Genotyper) on the children’s samples calculated by truth set-based benchmarking and estimated with trio-based benchmarking, using all four million SNPs

Precision
Recall
HCUGΔ(103)HCUGΔ(103)
HG002Trutha0.99800.99423.810.99940.99880.56
trio0.95540.95292.500.99880.99850.33
σtrio± 0.0076± 0.0076± 0.05± 0.0006± 0.0006± 0.05
NA12877Truthb0.99860.99632.230.99020.9912–1.02
trio0.95250.94992.630.98340.9839–0.47
σtrio± 0.0006± 0.0006± 0.02± 0.0001± 0.0001± 0.02
NA12878Truthb0.99860.99652.150.99100.9920–1.04
trio0.99450.99172.790.99640.9969–0.46
σtrio± 0.0008± 0.0008± 0.02± 0.0003± 0.0003± 0.02
Precision
Recall
HCUGΔ(103)HCUGΔ(103)
HG002Trutha0.99800.99423.810.99940.99880.56
trio0.95540.95292.500.99880.99850.33
σtrio± 0.0076± 0.0076± 0.05± 0.0006± 0.0006± 0.05
NA12877Truthb0.99860.99632.230.99020.9912–1.02
trio0.95250.94992.630.98340.9839–0.47
σtrio± 0.0006± 0.0006± 0.02± 0.0001± 0.0001± 0.02
NA12878Truthb0.99860.99652.150.99100.9920–1.04
trio0.99450.99172.790.99640.9969–0.46
σtrio± 0.0008± 0.0008± 0.02± 0.0003± 0.0003± 0.02

Note: Δ denotes the difference between HC and UG values. σtrio is self-reported uncertainty of the model, i.e. SD of the Gibbs samples.

With aGIAB (HG002), and bPlatinum Genomes truth VCF and BED files.

Table 2.

Precision and recall of the two pipeline (HC: Haplotype Caller, UG: Unified Genotyper) on the children’s samples calculated by truth set-based benchmarking and estimated with trio-based benchmarking, using all four million SNPs

Precision
Recall
HCUGΔ(103)HCUGΔ(103)
HG002Trutha0.99800.99423.810.99940.99880.56
trio0.95540.95292.500.99880.99850.33
σtrio± 0.0076± 0.0076± 0.05± 0.0006± 0.0006± 0.05
NA12877Truthb0.99860.99632.230.99020.9912–1.02
trio0.95250.94992.630.98340.9839–0.47
σtrio± 0.0006± 0.0006± 0.02± 0.0001± 0.0001± 0.02
NA12878Truthb0.99860.99652.150.99100.9920–1.04
trio0.99450.99172.790.99640.9969–0.46
σtrio± 0.0008± 0.0008± 0.02± 0.0003± 0.0003± 0.02
Precision
Recall
HCUGΔ(103)HCUGΔ(103)
HG002Trutha0.99800.99423.810.99940.99880.56
trio0.95540.95292.500.99880.99850.33
σtrio± 0.0076± 0.0076± 0.05± 0.0006± 0.0006± 0.05
NA12877Truthb0.99860.99632.230.99020.9912–1.02
trio0.95250.94992.630.98340.9839–0.47
σtrio± 0.0006± 0.0006± 0.02± 0.0001± 0.0001± 0.02
NA12878Truthb0.99860.99652.150.99100.9920–1.04
trio0.99450.99172.790.99640.9969–0.46
σtrio± 0.0008± 0.0008± 0.02± 0.0003± 0.0003± 0.02

Note: Δ denotes the difference between HC and UG values. σtrio is self-reported uncertainty of the model, i.e. SD of the Gibbs samples.

With aGIAB (HG002), and bPlatinum Genomes truth VCF and BED files.

In Figure 4, we plot the deviation of the trio-based estimate from the true value as a function of number of variants. While the estimation error of the metrics themselves hovers around 0.1–0.01 even when large number of variants are considered, the model’s error on the differential metrics is around 103 for large number of variants, and stay below 5×103 even for a mere 1000 variants. Recall values (both absolute and differential) are estimated more accurately then precision.

Fig. 4.

Estimation errors. Top: Difference between estimated (from trio) and true values (from truth set) of precision and recall. Bottom: Difference of the estimated and true differential precision and recall. Markers show the results obtained from the validation experiments run on sub-sampled variants. Dashed lines highlight the 90th percentile of each group

To understand the reason why our model is much better at estimating differential metrics than the metrics themselves, we plot the entries of the genotype confusion matrix (n) for NA12878 in Figure 5. Our model accurately estimates the number of loci where either one of the pipelines makes an incorrect call, but not both. Since these entries of the confusion matrix contribute the most to differential performance, it is no surprise that the difference in precision and recall are accurately estimated, even if their actual values are not. We can intuitively understand this disparity in the following way: We expect the two pipelines to have similar performance. Only the 27 diagonal elements (G1=G2) of N convey information about this common performance. On the other hand, all off-diagonal elements (G1G2) tell us something valuable about the differential performance. Since there are more of the latter, they paint a more detailed picture and allow us to estimate the differences more accurately.

Fig. 5.

Genotype confusion matrix of NA12878. True values are shown alongside with the estimates obtained from trio-based benchmarking. Error bars on the estimates indicate 1st and 99th percentiles of the samples from the Gibbs sampler. (See Supplementary Fig. S6 for HG002 and NA12877)

5 Discussion

Aggregating observed Mendelian violations across many loci in related individuals provides an approximate notion of the accuracy of variant calling pipelines. When comparing two pipelines, we expect the better one to produce fewer Mendelian inconsistencies, and indeed, as shown in Table 1, this is the case: Haplotype Caller produces fewer Mendelian violations in all three trios, and makes fewer genotyping errors for all three children.

In the light of our results in Table 2, two caveats of this naive method are immediately visible: First, the numbers of Mendelian violations do not accurately reflect how much better is the better pipeline. Second, the bare counts of Mendelian violations do not even hint that Unified Genotyper actually has a higher recall on the samples NA12877 and NA12878, something our trio-based benchmarking method estimates correctly (Table 2). This exemplifies that estimating precise quantitative differences between variant caller pipelines, in the absence of a reliable truth set, is a non-trivial task. As we demonstrated, our method can do this with high accuracy.

Previous trio-based benchmarking approaches range from fitting a calibration curve between observed number of Mendelian violations and true number of errors (Hao et al., 2004), to modeling haplotypes and recombination events during meiosis (Kojima et al., 2013; Markus et al., 2011; Peng et al., 2013). All previous approaches focus on a set of variants produced by a single pipeline, disregarding all information about the correlation between pipelines. We showed that by analyzing the joint counts (N) of the called genotype trios from two pipelines one can estimate differential performance with high accuracy (with uncertainty of 103). In fact, exactly because of the information contained in the correlations, the differential metrics can be estimated with more than an order of magnitude lower uncertainty than the metrics themselves. As a consequence, our uncertainty is an order of magnitude lower than it was previously achieved with dyads (Haaland and Skaug, 2013), and comparable to the uncertainties obtained from pure simulations for trios (Hao et al., 2004).

Although our current method is limited to using bi-allelic variants from trios, the mathematical framework enables straightforward generalization. Data from multi-allelic variants and larger pedigrees can be incorporated by expanding the sets I and T. The demand of computational resources, which increases exponentially with the sizes of I and T, can be curbed by truncating the model to limit the number of genotyping errors per locus, which enables implementation with sparse arrays.

One limitation of our method is the need for harmonized variant representation in the input. While this problem is solved for trios by Toptaş et al. (2018), there is no easily-deployable method to faithfully match six samples with different variant representation. Another limitation, stemming from the limitation of the input data, is that some of the Mendelian-consistent trios are in fact results of double (or triple) errors. Our method relies on explicit assumptions about error profiles, its result is accurate only if these assumptions hold.

Our method estimates aggregate metrics. The estimated complete distribution N and the person-specific confusion matrices n(p) contain a wealth of additional information that can be directly used to improve the performance of variant calling. Bayesian model averaging [e.g. Fragoso and Neto (2015)] can be used to reconcile genotypes at loci where the pipelines do not agree. By counting how often one pipeline is right when the other is wrong for each called trio combination (G1,G2), one can estimate the posterior probability of the correct genotype, P(g|G1,G2). E.g. from the confusion matrix n shown on Figure 5, we can calculate the probability of HC being correct when HC and UG call 01 and 00, respectively: P(01|01,00)=n01,01,00/iIni,01,00(0.72). One can imagine extending this scheme to a council of pipelines where, instead of giving equal say to each pipeline, a weighted voting is carried out to determine the genotype of each variant.

Acknowledgements

Discussions with Yilong Li, Lizao Li, Maxime Huvet, Amit Jain, Milos Popovic, Aqeel Ahmed, Maria Suciu, Sun-Gou Ji, Ivan Johnson, Kaushik Ghose, İlker Gündoğdu were very valuable at multiple stages of this work. The authors are grateful to them for their insights and suggestions.

Funding

This work was supported in part by UK Department of Health grant SBRI Genomics Competition: Enabling Technologies for Genomic Sequence Data Analysis and Interpretation administered by Genomics England.

Conflict of Interest: none declared.

References

Auton
 
A.
 et al.  (
2015
)
A global reference for human genetic variation
.
Nature
,
526
,
68
74
.

Bamshad
 
M.J.
 et al.  (
2011
)
Exome sequencing as a tool for Mendelian disease gene discovery
.
Nat. Rev. Genet
.,
12
,
745
755
.

Boutros
 
P.C.
 et al.  (
2014
)
Toward better benchmarking: challenge-based methods assessment in cancer genomics
.
Genome Biol
.,
15
,
462.

Browning
 
B.L.
,
Browning
S.R.
(
2013
)
Detecting identity by descent and estimating genotype error rates in sequence data
.
Am. J. Hum. Genet
.,
93
,
840
851
.

Chen
 
W.
 et al.  (
2013
)
Genotype calling and haplotyping in parent-offspring trios
.
Genome Res
.,
23
,
142
151
.

Cornish
 
A.
,
Guda
C.
(
2015
)
A comparison of variant calling pipelines using genome in a bottle as a reference
.
BioMed. Res. Int
.,
2015
,
1.

DePristo
 
M.A.
 et al.  (
2011
)
A framework for variation discovery and genotyping using next-generation DNA sequencing data
.
Nat. Genet
.,
43
,
491
498
.

Douglas
 
J.A.
 et al.  (
2002
)
Probability of detection of genotyping errors and mutations as inheritance inconsistencies in nuclear-family data
.
Am. J. Hum. Genet
.,
70
,
487
495
.

Eberle
 
M.A.
 et al.  (
2017
)
A reference data set of 5.4 million phased human variants validated by genetic inheritance from sequencing a three-generation 17-member pedigree
.
Genome Res
.,
27
,
157
164
.

Fang
 
L.
 et al.  (
2016
) Evaluation on efficient detection of structural variants at low coverage by long-read sequencing. bioRxiv, 092544.

Fragoso
 
T.M.
,
Neto
F.L.
(
2015
) Bayesian model averaging: a systematic review and conceptual classification. arXiv, 1509.08864.

Haaland
 
Ø.A.
,
Skaug
H.J.
(
2013
)
Estimating genotyping error rates from parent-offspring dyads
.
Stat. Prob. Lett
.,
83
,
812
819
.

Hao
 
K.
 et al.  (
2004
)
Estimation of genotype error rate using samples with pedigree information–an application on the GeneChip Mapping 10K array
.
Genomics
,
84
,
623
630
.

Heid
 
I.M.
 et al.  (
2008
)
Estimating the single nucleotide polymorphism genotype misclassification from routine double measurements in a large epidemiologic sample
.
Am. J. Epidemiol
.,
168
,
878
889
.

Human Genome Structural Variant Consortium
. (
2017
) Multi-platform discovery of haplotype-resolved structural variation in human genomes. bioRxiv, 193144.

Hwang
 
S.
 et al.  (
2015
)
Systematic comparison of variant calling pipelines using gold standard personal exome variants
.
Sci. Rep
.,
5
,
17875.

Johnson
 
P.C.D.
,
Haydon
D.T.
(
2007
)
Maximum-likelihood estimation of allelic dropout and false allele error rates from microsatellite genotypes in the absence of reference data
.
Genetics
,
175
,
827
842
.

Jostins
 
L.
(
2011
) Inferring genotyping error rates from genotyped trios. arXiv, 1109.1462.

Kojima
 
K.
 et al.  (
2013
)
A statistical variant calling approach from pedigree information and local haplotyping with phase informative reads
.
Bioinformatics
,
29
,
2835
2843
.

Korostishevsky
 
M.
 et al.  (
2009
)
Parametric model-based statistics for possible genotyping errors and sample stratification in sibling-pair SNP data
.
Genet. Epidemiol
.,
34
,
26
33
.

Li
 
H.
(
2011
)
A statistical framework for SNP calling, mutation discovery, association mapping and population genetical parameter estimation from sequencing data
.
Bioinformatics
,
27
,
2987
2993
.

Li
 
H.
(
2014
)
Toward better understanding of artifacts in variant calling from high-coverage samples
.
Bioinformatics
,
30
,
2843
2851
.

Li
 
H.
,
Durbin
R.
(
2009
)
Fast and accurate short read alignment with Burrows-Wheeler transform
.
Bioinformatics
,
25
,
1754
1760
.

Mallick
 
S.
 et al.  (
2016
)
The Simons genome diversity project: 300 genomes from 142 diverse populations
.
Nature
,
538
,
201
206
.

Markus
 
B.
 et al.  (
2011
)
Integration of SNP genotyping confidence scores in IBD inference
.
Bioinformatics
,
27
,
2880
2887
.

McKenna
 
A.
 et al.  (
2010
)
The Genome Analysis Toolkit: a MapReduce framework for analyzing next-generation DNA sequencing data
.
Genome Res
.,
20
,
1297
1303
.

Nutsua
 
M.E.
 et al.  (
2015
)
Family-based benchmarking of copy number variation detection software
.
Plos One
,
10
,
e0133465.

Olson
 
N.D.
 et al.  (
2015
)
Best practices for evaluating single nucleotide variant calling methods for microbial genomics
.
Front. Genet
.,
6
,
235.

Parikh
 
H.
 et al.  (
2016
)
svclassify: a method to establish benchmark structural variant calls
.
BMC Genomics
,
17
,
64.

Peng
 
G.
 et al.  (
2013
)
Rare variant detection using family-based sequencing analysis
.
Proc. Natl. Acad. Sci
.,
110
,
3985
3990
.

Sandmann
 
S.
 et al.  (
2017
)
Evaluating variant calling tools for non-matched next-generation sequencing data
.
Sci. Rep
.,
7
,
43169.

Saunders
 
I.W.
 et al.  (
2007
)
Estimating genotyping error rates from Mendelian errors in SNP array genotypes and their impact on inference
.
Genomics
,
90
,
291
296
.

Shringarpure
 
S.S.
 et al.  (
2015
)
Inexpensive and highly reproducible cloud-based variant calling of 2, 535 human genomes
.
PLoS One
,
10
,
e0129277.

Sobel
 
E.
 et al.  (
2002
)
Detection and integration of genotyping errors in statistical genetics
.
Am. J. Hum. Genet
.,
70
,
496
508
.

Talwalkar
 
A.
 et al.  (
2014
)
SMASH: a benchmarking toolkit for human genome variant calling
.
Bioinformatics
,
30
,
2787
2795
.

Toptaş
 
B.Ç.
 et al.  (
2018
) Comparing complex variants in family trios. bioRxiv, 253492.

Van der Auwera
 
G.A.
 et al.  (
2013
)
From FastQ data to high-confidence variant calls: the genome analysis toolkit best practices pipeline
.
Curr. Protocols Bioinform
.,
11
,
11.10.1
11.10.33
.

Veltman
 
J.A.
,
Brunner
H.G.
(
2012
)
De novo mutations in human genetic disease
.
Nat. Rev. Genet
.,
13
,
565
575
.

Wang
 
J.
(
2004
)
Sibship reconstruction from genetic data with typing errors
.
Genetics
,
166
,
1963
1979
.

Zook
 
J.M.
 et al.  (
2014
)
Integrating human sequence data sets provides a resource of benchmark SNP and indel genotype calls
.
Nat. Biotechnol
.,
32
,
246
251
.

Zook
 
J.M.
 et al.  (
2016
)
Extensive sequencing of seven human genomes to characterize benchmark reference materials
.
Sci. Data
,
3
,
160025.

This is an Open Access article distributed under the terms of the Creative Commons Attribution Non-Commercial License (http://creativecommons.org/licenses/by-nc/4.0/), which permits non-commercial re-use, distribution, and reproduction in any medium, provided the original work is properly cited. For commercial re-use, please contact journals.permissions@oup.com
Associate Editor: Oliver Stegle
Oliver Stegle
Associate Editor
Search for other works by this author on:

Supplementary data