Skip to main content

Volume 8 Supplement 1

Genetic Analysis Workshop 18

Imputation in families using a heuristic phasing approach

Abstract

Whole genome sequencing (WGS) remains prohibitively expensive, which has encouraged the development of methods to impute WGS data into nonsequenced individuals using a framework of single nucleotide polymorphisms genotyped for genome-wide association studies (GWAS). Although successful methods have been developed for cohorts of unrelated individuals, current imputation methods in related individuals are limited by pedigree size, by the distance of relationships, or by computation time. In this article, we describe a method for imputation in arbitrarily shaped multigenerational pedigrees that can impute genotypes across distantly related individuals based on identity by descent. We evaluate this approach using GWAS data and apply this approach to WGS data distributed for Genetic Analysis Workshop 18.

Background

Recent years have seen a sharp increase in the throughput of genotyping in human cohorts represented largely by two technologies: microarray-based approaches that genotype hundreds of thousands of markers tagging common haplotype blocks for the purpose of genome-wide association studies (GWAS) and WGS, which allows near comprehensive discovery of genotypes. Many groups have the resources to genotype entire cohorts for GWAS; however, WGS currently remains prohibitively expensive. In light of this, imputation of WGS data from reference panels using available GWAS data has been adopted as an approach to maximize the utility of available resources [1].

Merlin [2] and Mendel [3] are two programs that have built-in options for genotype imputation designed for working with pedigrees. However, these two methods have limited ability to handle large pedigrees and do not impute variants across more distantly related individuals in the same pedigree. Markov chain Monte Carlo (MCMC) methods that sample across potential identity-by-descent (IBD) states are an approach that makes broader use of the information contained between more distant relatives but are still currently being developed as an imputation approach [4]. However, this approach requires iterative sampling that is computationally expensive and may limit its utility in laboratories with limited computing resources. An ideal imputation approach would be highly accurate and computationally fast and would consider all chromosomal segments that are identical by descent within the pedigree.

In this article, we describe and evaluate a computationally feasible rules-based approach for phasing and imputation that can impute across distantly related individuals within complex pedigrees.

Methods

Data handling and marker location annotation

WGS data was managed using VCFtools [5]. GWAS marker locations for NCBI Build GRCh37/hg19 were annotated using SNPnexus [6].

Assumptions of our imputation approach

Our approach requires two sets of genotyping data. The first set (set 1), generally GWAS SNP data, is used to identify chromosomal segments that are IBD. The second set (set 2), either dense GWAS or WGS data, consists of variants that are incompletely genotyped in individuals with set 1 data. Using identity by descent, set 2 genotypes are imputed into individuals with missing genotypes. Our approach requires correct knowledge of the pedigree structure and all individuals to have set 1 data. Our approach breaks pedigrees containing individuals without set 1 data into smaller pedigrees with complete data.

Phasing pedigrees using the genome-wide association studies framework

Using the GWAS framework (set 1), we first find all available trios in the pedigree and phase the offspring and parents according to rules of inheritance for diallelic markers. In our view, two subtypes of nonfounder chromosomes lend themselves to distinct approaches for phasing and identification of recombination events: chromosomes that are the product of a single round of meiosis within the pedigree and chromosomes that are the product of two or more rounds of meiosis within the pedigree. It is important to note that nonfounders can carry both of the aforementioned subtypes of nonfounder chromosomes as illustrated in Figure 1.

Figure 1
figure 1

An example pedigree partially simulated from pedigree 10 from Genetic Analysis Workshop 18 data. Founders are shown in red, individuals carrying nonfounding chromosomes that are the product of a single meiosis are shown in blue, and individuals carrying nonfounding chromosomes that are products of two or more meioses are shown in yellow.

Cross-over events for nonfounder chromosomes that have experienced two or more meioses within the pedigree can be determined using rules of inheritance for diallelic markers. To implement this approach, we find all cases in which a parent in a trio is an offspring in another trio such as ID 651 in Figure 1, who is the offspring in a trio with 652 and 653, and a parent in a trio with 619 and 650. The exact phase of 651 and 650 is known from the trio phasing stage. With this information, each phased locus where 651 is heterozygous represents an unambiguous instance where the genotype that 650 inherited from 651 is identical by descent to a genotype from either 652 or 653. We applied this concept to identify the recombination events between informative markers and stored the IBD segments between the recombination events and their 3-generation paths of inheritance.

All other nonfounder chromosomes in the pedigree are the result of recombination events during a single meiosis within the pedigree and are only carried by offspring of a pedigree founder. For this subset of nonfounder chromosomes, cross-over events cannot be determined using rules of inheritance as they can for those just discussed. Within this subset of nonfounder chromosomes, we applied a strategy aimed at accomplishing two goals: (a) to identify observable recombination events in the offspring and (b) to create a representation of the founder's phase that is as close to their true phase as possible and is consistent with the observable recombination events in their offspring. To accomplish this task, we implemented a version of the minimum recombination model [7]. The exact phase of founder offspring is known from trio phasing. Given this information, markers that are heterozygous in the founder and phased in their offspring can be dichotomized into identical by descent groups corresponding to the two haploid genotypes carried by the founder. Multiple markers along long segments of the chromosome show consistent dichotomized groups. Instances where the members of these groups change between adjacent informative markers indicate the location of a recombination event. Our model assumes that the minimum number of recombination events needed to explain the change in dichotomized groups represents the true number of recombination events. In cases in which a founder has two offspring, it is possible to identify recombination events, but it cannot be determined which offspring harbors the recombination event, as elegantly shown by Roach et al [8]. For these cases, we arbitrarily assign the recombination event to one of the offspring. Last, for founders with a single offspring, we use the phased chromosome inherited by the offspring as a proxy for the true phase of the founder. This approach allows us to create a single representation of the founder's phase that fits the identifiable recombination events in their offspring without violating any rules of inheritance. After applying these approaches, we store the IBD segments between the observable recombination events and their corresponding 2-generation paths of inheritance.

Identifying exact paths of inheritance for all identity-by-descent segments

Using the approach for phasing outlined, all individuals with set 1 genotypes will be phased. Two-generation or 3-generation paths of inheritance for all IBD segments of each phased chromosome will be known. We use the available 2-generation and 3-generation paths of inheritance to trace the IBD segments to an exact phased founder chromosome. To do this, we implement a recursive algorithm that traverses all potential paths of inheritance from each founding chromosome. During each step representing a meiosis traversed by the algorithm, segments inherited from the current founding chromosome are passed on to the next generation according to their overlap with segments discovered to have been inherited along the current path. The end result is a list of IBD segments and their paths of inheritance, which summarizes the genotypes observed in nonfounders in terms of the founding chromosomes. We store this information as a list of IBD segments and their paths of inheritance, which we call a nonfounder matrix.

Diploid genotype imputation

We then leverage the IBD information and paths of inheritance stored in the nonfounder matrix to impute genotypes among individuals within a pedigree. To do this, we first phase all set 2 genotypes possible using trio phasing and by splitting homozygous genotypes. In doing so, we unambiguously map each haploid genotype to a specific IBD segment stored in the nonfounder matrix. We then use the paths of inheritance for each IBD segment stored in the nonfounder matrix to impute these haploid genotypes into the founding chromosomes. If a sequenced founder is heterozygous for a marker and only one haploid genotype could be imputed onto a specific phased chromosome, we infer the corresponding haploid genotype on the paired chromosome given the sequenced diploid genotype. In any individual within the pedigree, a diploid genotype can be accounted for by the two haploid genotypes inherited from pedigree founders. Diploid genotypes are then imputed by summing the two haploid genotypes identical by descent to founding chromosomes as recorded in the nonfounder matrix. As an example, using these procedures, a haploid genotype on an IBD segment shared between 650 and 583 that is genotyped and phased in 650 could be imputed into 629 if 629 also shares a segment IBD to 583 at that locus.

Results

To estimate the accuracy of the described method, we split the provided GWAS data evenly into two subsets for use as set 1 and set 2 genotyping data. Fifty percent of set 2 genotypes were randomly masked from the imputation procedures. The outlined procedures were followed, and IQS [9], a statistic that corrects for random concordance between imputed and known genotypes, was calculated by comparing the imputed genotypes to the masked genotypes. The mean IQS was 0.992 for 211,736 markers (18,498,441 imputed diploid genotypes) for which the chance concordance was less than 1. This high accuracy was robust across the minor allele frequency spectrum, calculated using the set of 157 unrelated individuals provided by the data distributors. For markers with MAF in the ranges 0 to 0.01, greater than 0.01 to 0.05, greater than 0.05 to 0.1, greater than 0.1 to 0.2, greater than 0.2 to 0.3, greater than 0.3 to 0.4, and greater than 0.4 to 0.5 the mean IQS was 0.972, 0.985, 0.990, 0.992, 0.993, 0.994, and 0.994, respectively. To assess the robustness of this approach to the availability of set 2 data, we repeated this masking experiment, this time randomly masking genotypes using a randomly generated probability ranging from 0 to 1 for each marker. This test showed that the accuracy of the described imputation approach is robust across levels of available data. The overall mean IQS for this experiment was 0.991 for 187,793 markers (11,242,219 imputed diploid genotypes) for which the chance concordance was less than 1. For markers with 0 to 0.1, greater than 0.1 to 0.25, greater than 0.25 to less than 0.75, 0.75 to less than 0.9, and less than 0.9 to 1 of diploid genotypes available, the mean IQS across markers was 0.984, 0.988, 0.992, 0.993, and 0.994, respectively. The percentage of the masked genotypes that this approach was able to impute was positively correlated with the percentage of set 2 genotypes that were known.

To assess the utility of this approach in a real-world application, we used the provided GWAS data as set 1 and the provided WGS data as set 2. Using the procedures described herein, we imputed WGS data for all odd-numbered autosomes into 408 individuals (227 with sequence data and 181 without sequence data) from 16 pedigrees containing sequenced individuals. In individuals who were not sequenced, we imputed 1.66 × 109 and 1.09 × 108 homozygous and heterozygous genotypes, respectively, an average of 9.17 × 106 and 6.00 × 105 imputed homozygous and heterozygous genotypes per individual, respectively. This represents a 132% return on investment per sequenced diploid genotype in these pedigrees.

Discussion

We have developed a method for imputing WGS data in arbitrarily shaped pedigrees using a GWAS framework. As a step toward achieving this, we have developed a heuristic method to phase whole chromosomes in arbitrarily shaped multigenerational pedigrees. Our approach differs from previous approaches in that it organizes chromosomes according to the number of rounds of meiosis they have experienced in the pedigree and implements distinct strategies for phasing and identification of recombination events for these chromosomes.

In this study, we applied no filters for markers that display genotyping errors in trios, have de novo mutations within the pedigree or overlap copy number variable regions. When comparing imputed WGS data with known genotypes, 61,360 of 700,423 (8.8%) markers with at least one incorrect imputed diploid genotype fell within copy number variable regions previously identified in individuals within the GAW18 dataset [10], a clear enrichment compared to the 6.8% expected to fall into these regions by chance based on the portion of these chromosomes that were variable on a per nucleotide basis (p = 2.47 × 10−323, two-sided binomial test). More strikingly, 37.4% fell within regions reported in the Database of Genomic Variants [11]. Therefore, evidence suggests that this approach would be improved by incorporating structural variation.

Our method requires all individuals within a pedigree to have set 1 genotyping data. Given this, MCMC methods are likely to be superior for imputation in pedigrees with many or key missing individuals. However, in pedigrees with complete set 1 data, the method described herein imputes across all segments that are identical by descent with nearly perfect accuracy. The described masking experiment ran in 7 minutes for chromosome 1 in pedigree 47 on a Lenovo ThinkStation S20 with an Intel Xeon 2.40 GHz CPU. All procedures described in this manuscript were run on this same machine. Thus, this approach is computationally feasible for small laboratories. Taken together, in pedigrees with complete data, the described method is highly accurate and computationally feasible and considers all chromosomal segments that are identical by descent within the pedigree.

Conclusions

We have developed an accurate and computationally feasible method for phasing and imputation in large arbitrarily shaped multigenerational pedigrees. In pedigrees with a complete GWAS framework data, this method is able to impute genotypes across all IBD segments within the pedigree. Our results show that an imputation strategy based on genetic phasing of GWAS data can be a successful approach to imputation in multigenerational pedigrees.

References

  1. Howie B, Fuchsberger C, Stephens M, Marchini J, Abecasis GR: Fast and accurate genotype imputation in genome-wide association studies through pre-phasing. Nat Genet. 2012, 44: 955-959. 10.1038/ng.2354.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  2. Abecasis GR, Cherny SS, Cookson WO, Cardon LR: Merlin--rapid analysis of dense genetic maps using sparse gene flow trees. Nat Genet. 2002, 30: 97-101. 10.1038/ng786.

    Article  CAS  PubMed  Google Scholar 

  3. Chen GK, Wang K, Stram AH, Sobel EM, Lange K: Mendel-GPU: haplotyping and genotype imputation on graphics processing units. Bioinformatics. 2012, 28: 2979-2980. 10.1093/bioinformatics/bts536.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  4. Wijsman EM, Rothstein JH, Thompson EA: Multipoint linkage analysis with many multiallelic or dense diallelic markers: Markov chain-Monte Carlo provides practical approaches for genome scans on general pedigrees. Am J Hum Genet. 2006, 79: 846-858. 10.1086/508472.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  5. Danecek P, Auton A, Abecasis G, Albers CA, Banks E, DePristo MA, Handsaker RE, Lunter G, Marth GT, Sherry ST, et al: The variant call format and VCFtools. Bioinformatics. 2011, 27: 2156-2158. 10.1093/bioinformatics/btr330.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  6. Chelala C, Khan A, Lemoine NR: SNPnexus: a web database for functional annotation of newly discovered and public domain single nucleotide polymorphisms. Bioinformatics. 2009, 25: 655-661. 10.1093/bioinformatics/btn653.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  7. Qian D, Beckmann L: Minimum-recombinant haplotyping in pedigrees. Am J Hum Genet. 2002, 70: 1434-1445. 10.1086/340610.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  8. Roach JC, Glusman G, Hubley R, Montsaroff SZ, Holloway AK, Mauldin DE, Srivastava D, Garg V, Pollard KS, Galas DJ, et al: Chromosomal haplotypes by genetic phasing of human families. Am J Hum Genet. 2011, 89: 382-397. 10.1016/j.ajhg.2011.07.023.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  9. Lin P, Hartz SM, Zhang Z, Saccone SF, Wang J, Tischfield JA, Edenberg HJ, Kramer JR, A MG, Bierut LJ, et al: A new statistic to evaluate imputation reliability. PLoS One. 2010, 5: e9697-10.1371/journal.pone.0009697.

    Article  PubMed Central  PubMed  Google Scholar 

  10. Blackburn A, Goring HH, Dean A, Carless MA, Dyer T, Kumar S, Fowler S, Curran JE, Almasy L, Mahaney M, et al: Utilizing extended pedigree information for discovery and confirmation of copy number variable regions among Mexican Americans. Eur J Hum Genet. 2013, 21: 404-409. 10.1038/ejhg.2012.188.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  11. Iafrate AJ, Feuk L, Rivera MN, Listewnik ML, Donahoe PK, Qi Y, Scherer SW, Lee C: Detection of large-scale variation in the human genome. Nat Genet. 2004, 36: 949-951. 10.1038/ng1416.

    Article  CAS  PubMed  Google Scholar 

Download references

Acknowledgements

We thank the participants of the San Antonio Family Studies (San Antonio Family Heart Study and San Antonio Family Diabetes/Gallbladder Study). We also thank the current and past investigators and staff of these studies and those of the Type 2 Diabetes Genetic Exploration by Next-generation sequencing in Ethnic Samples (T2D-GENES) Consortium for providing the data. The Genetic Analysis Workshop 18 (GAW18) WGS data were provided by the T2D-GENES Consortium, which is supported by National Institutes of Health (NIH) grants U01 DK085524, U01 DK085584, U01 DK085501, U01 DK085526, and U01 DK085545. The other genetic and phenotypic data for GAW18 were provided by the San Antonio Family Heart Study and San Antonio Family Diabetes/Gallbladder Study, which are supported by NIH grants P01 HL045222, R01 DK047482, and R01 DK053889. The GAW is supported by NIH grant R01 GM031575.

This article has been published as part of BMC Proceedings Volume 8 Supplement 1, 2014: Genetic Analysis Workshop 18. The full contents of the supplement are available online at http://www.biomedcentral.com/bmcproc/supplements/8/S1. Publication charges for this supplement were funded by the Texas Biomedical Research Institute.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Donna M Lehman.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors' contributions

ANB conceived of the phasing, storage, and imputation procedures and designed the overall study. ANB and AKD implemented the ideas using the perl scripting language. ANB, AKD, and DML all contributed to the development of the procedures described. ANB and DML drafted the manuscript. All authors read and approved the final manuscript.

Rights and permissions

Open Access  This article is licensed under a Creative Commons Attribution 4.0 International License, which permits use, sharing, adaptation, distribution and reproduction in any medium or format, as long as you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons licence, and indicate if changes were made.

The images or other third party material in this article are included in the article’s Creative Commons licence, unless indicated otherwise in a credit line to the material. If material is not included in the article’s Creative Commons licence and your intended use is not permitted by statutory regulation or exceeds the permitted use, you will need to obtain permission directly from the copyright holder.

To view a copy of this licence, visit https://creativecommons.org/licenses/by/4.0/.

The Creative Commons Public Domain Dedication waiver (https://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated in a credit line to the data.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Blackburn, A.N., Dean, A.K. & Lehman, D.M. Imputation in families using a heuristic phasing approach. BMC Proc 8 (Suppl 1), S16 (2014). https://doi.org/10.1186/1753-6561-8-S1-S16

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/1753-6561-8-S1-S16

Keywords