Skip to main content

Predicting the combined effect of multiple genetic variants

Abstract

Background

Many genetic variants have been identified in the human genome. The functional effects of a single variant have been intensively studied. However, the joint effects of multiple variants in the same genes have been largely ignored due to their complexity or lack of data. This paper uses HMMvar, a hidden Markov model based approach, to investigate the combined effect of multiple variants from the 1000 Genomes Project. Two tumor suppressor genes, TP53 and phosphatase and tensin homolog (PTEN), are also studied for the joint effect of compensatory indel variants.

Results

Results show that there are cases where the joint effect of having multiple variants in the same genes is significantly different from that of a single variant. The deleterious effect of a single indel variant can be alleviated by their compensatory indels in TP53 and PTEN. Compound mutations in two genes, β-MHC and MyBP-C, leading to severer cardiovascular disease compared to single mutations, are also validated.

Conclusions

This paper extends the functionality of HMMvar, a tool for assigning a quantitative score to a variant, to measure not only the deleterious effect of a single variant but also the joint effect of multiple variants. HMMvar is the first tool that can predict the functional effects of both single and general multiple variations on proteins. The precomputed scores for multiple variants from the 1000 Genomes Project and the HMMvar package are available at https://bioinformatics.cs.vt.edu/zhanglab/HMMvar/

Introduction

Identifying the deleterious effects of a variant is significant for disease studies. Different types of variation data have been identified with advances in sequencing technologies. Single nucleotide polymorphism (SNP) is the largest group of mutations in the variants identified so far in humans, and numerous methods have been developed for predicting the functional effects of SNPs. The second most common type of mutations is indel, referring to insertion or deletion of nucleotide bases. More and more indels have been discovered to be associated with diseases or cancers. Frameshift indels are expected to have large effects on protein functions (loss of function), since they change the reading frame of a gene thus change amino acids and probably the functions of proteins. Compared to SNPs, less work has been done on predicting the functional effect of indels.

Methods for predicting the functional effects of different types of variants are typically grouped into two classes [1], conservation-based predictor and trained classifier. Previous studies mainly concern SNPs, and a few dozen computer programs and web servers are devoted to predicting the effects of SNP variants. For example, SIFT SNP [2] is a conservation-based predictor and PolyPhen [3] is a trained classifier. Recent indel prediction studies include an evolutionary conservation-based approach for both coding and noncoding regions [4], a trained classifier method for frameshift variants [5], and another evolutionary conservation-based method for multiple types of variation [6]. A limitation of all these methods is that they only predict the effect of a single variant and cannot measure the functional effect of a set of variants in their entirety. Complex diseases are likely to be caused by multiple genes and/or multiple mutations on individual genes [7], so quantitatively measuring the effect of multiple variants together should be helpful for detecting causal genes/mutations for diseases. For example, it has been shown that the correlation between breast cancer and multiple SNPs of the ORAI1 gene is more significant than that with single SNPs [8]. The authors use a genetic algorithm to find combinations of SNPs along with their genotypes that are significantly different between the case group and the control group. The results reveal that new insights in cancer studies are possible by considering the joint effect of multiple variants or the associations among genetic variants. Other work [9, 10] concerns the variants C677T (alanine to valine) in the catalytic domain and A1298C (glutamate to alanine) in the regulatory domain of the methylenetetrahydrofolate reductase (MTHFR) gene, known to decrease the activity of the MTHFR gene and that patients could be inappropriately counseled for being at high risk for thrombotic episodes due to the difficulty of distinguishing between cis compound heterozygotes and trans compound heterozygotes. Therefore, it is important to study the joint effect of multiple variants.

This paper focuses on predicting the joint effect of variants from a single gene using a previously proposed hidden Markov model, HMMvar [11]. As the hidden Markov model is computed from the multiple protein sequence alignment for homologous proteins from different species, it reflects extent of evolutionary conservation naturally by its probabilistic profile. The probabilistic profile can be used to compute and compare the likelihood of generating mutant baring sequences given the HMM with the likelihood of generating mutant free sequences, i.e., wild type sequences, given the HMM. The lower the former compared with the latter, the more deleterious the mutants are likely. Therefore, HMMvar is able to predict the functional effect of a single mutation, as well as the joint effect of multiple mutations in coding regions.

To demonstrate the effectiveness of HMMvar, data from the 1000 Genomes project is used to identify genes that have multiple mutations, and HMMvar is used to predict the effect of multiple mutations on the genes identified. In addition, indels from two tumor suppressor genes, TP53 and phosphatase and tensin homolog (PTEN), are also used to investigate the effect of multiple indels from a single gene. If a frameshift indel occurs, it is possible that a nearby second indel rescues the gene by restoring the reading frame. There is a very limited knowledge about this kind of compensatory indels, but these are important because the deleterious effect of frameshift indels could be minimized by nearby compensatory indels. Hu and Pauline [5] claim that frameshift indels near each other are more likely to restore the translation frame. The present work found compensatory indel sets for TP53 and PTEN and measured the functional effects of individual indels and compensatory indel sets using HMMvar.

Materials and methods

Determine haplotypes by genotypes for the 1000 Genomes Project data

All the variants from the 1000 Genomes project Phase I along with their genotypes and ancestry alleles are collected to find the determined haplotype of an individual from a single gene. In order to quantitatively measure the effect of multiple variants on the same gene, the variant sets are formed in terms of their genotypes and the corresponding ancestral alleles. Given a certain gene and an individual sample, the variants are grouped into four classes based on the location and genotype. Figure 1 illustrates the classification of variants from a gene with three transcripts.

Fig. 1
figure 1

An example of variant classification in terms of genotypes. The colored sticks on the gene represent variants at different locations. Colors represent different classes of variants. The format v1:T;A|A means variant v1’s ancestral allele is T and the genotype is A|A, the same as other variants. The boxes on the transcripts represent exon regions. The gene and the transcripts share the same coordinate system

  • Class 1: variants that are in the coding regions and the genotypes are homozygous and different from the ancestry allele, as the red variants shown in Fig. 1.

  • Class 2: variants that are in the coding regions and the genotypes are homozygous and the same as the ancestry allele, as the green variants shown in Fig. 1.

  • Class 3: variants that are in the coding regions and the genotypes are heterozygous, as the blue variants shown in Fig. 1.

  • Class 4: variants that are not in the coding regions, such as 3’-utr, 5’-utr, or intron regions, as the orange variants shown in Fig. 1.

Only the variants in class 1 are kept as a set to be scored, because all the variants in Class 1 are homozygous and are mutants compared to the ancestral alleles. They can form a determined haplotype for a sample individual. As shown in the Fig. 1 example, a variant set is formed for each of the transcripts: Transcript 1 contains variant set {v 1,v 3}; Transcript 2 contains variant set {v 3,v 6,v 8}; Transcript 3 contains variant set {v 6,v 8}. Finally, these sets will be scored against the corresponding transcripts by HMMvar. The homozygotes detected in individual samples along with the set score are available in the database for further analysis.

For each gene (transcript by considering alternative splicing), all homologous genotype variants that are different from the ancestry allele are identified based on an individual sample. As a result, a transcript related to a certain gene might be associated with multiple variant sets due to the difference of genotypes among samples, and a variant set can also be associated with multiple transcripts due to alternative splicing. Table 1 shows an example illustrating the relationship between individual, gene, and variant set. Only the records related to two individuals are shown here as an example (there are actually 2566 records related to gene ABCB5). As shown, gene ABCB5 is associated with multiple variant sets and even the same transcript (NM_178559.5) is associated with multiple variant sets due to the difference of genotypes of different individuals. The same variant set corresponds to multiple transcripts and multiple individuals. Finally, processing all genes that contain at least one variant set with size greater than one yielded 67,109 variant sets from 8021 genes (14,917 transcripts) involving 1092 individual samples.

Table 1 Variants sets related to gene ABCB5

Compensatory indels in TP53 and PTEN

The indels from two tumor suppressor genes, TP53 and PTEN, are collected from two databases, International Agency for Research on Cancer (IARC) [12] and Catalogue of Somatic Mutations in Cancer (COSMIC) [13]. The 4736 variations (3565 for TP53 and 1171 for PTEN) include frameshift or in-frame insertions, deletions, and complexes (both insertion and deletion take place simultaneously in one location) in coding regions (Table 2).

Table 2 Data description

The effect of a deleterious mutation at the sequence level could be compensated for or alleviated by another mutation. For example, frameshift caused by a one base pair deletion could be recovered by a one base pair insertion nearby. A compensatory indel set is two or more indels that combine to preserve the open reading frame [14]. To simplify the search for compensatory indels, we restrict the consideration of compensatory indel sets, preserving the open reading frame, to those satisfying four conditions: (i) the number of nucleotides inserted or deleted per indel is less than five; (ii) the length of each indel is not divisible by three; (iii) the combined length of all indels is divisible by three; and (iv) all indels in the set occur within 20 base pairs. A single variant in a compensatory indel set is corrected (preserves the reading frame) by combining all other variants in the set. This paper considers the compensatory indel sets that satisfy the above four conditions for each of the TP53 variants and PTEN variants. Dynamic programming was used to find compensatory indel sets for single variants, which is similar to a subset sum problem [15], but with three different sums (−3, 0, and 3). To bound the computational effort, the maximum size of a compensatory indel set is bounded at 10, and the maximum number of compensatory indel sets for each valid length (sums −3, 0, and 3) is bounded at 20. The effects of compensatory indels are evaluated by comparing the HMMvar score of a single variant (as the mutant type) with the HMMvar score of a compensatory indel set (as the mutant type).

HMMvar

According to the theory of natural selection, different regions of a functional sequence are subject to different selective pressures. Multiple sequence alignment reveals this by residual conservation in certain positions. Some positions are more conserved than others and less tolerant to mutations. HMMvar [11] embodied this theory by using profile hidden Markov models [16] to predict the effect of mutations. A profile HMM captures the characteristics of a multiple sequence alignment, from which quantitative conservation information (a probability) is obtained. Thus, a high probability of generation from the profile HMM for the wild type sequence and a low probability for the mutant sequence suggest that the mutation might be deleterious. HMMvar measures the fitness of a sequence against the profile HMM that represents a set of homologous proteins (ideally only orthologous proteins from different species). So, it is natural for HMMvar to score a mutant sequence with one or multiple variants. This property also enables scoring the joint effect of compensatory indels (defined later in the section). The odds ratio

$$ O=\frac{P_{w}/(1-P_{w})}{P_{m}/(1-P_{m})} $$
((1))

is used to score the effect of indel mutations, where P w (P m ) is the probability that the wild type (mutated type) protein sequence could have been generated by the profile HMM trained on a homologous protein sequence set, usually calculated by the Viterbi algorithm. The higher the O is, the more deleterious the mutation or mutations. In general, when O>1, the mutation or mutations might be deleterious, when O≈1, the mutation or mutations might be neutral, and when O<1, the mutation or mutations might be beneficial. For scoring the effects of SNP mutation or mutations [11], the odds ratio score is not as reliable as the bit score (computed by the HMMER3 package) difference log2(P w /P m ) used here for SNPs.

Results

Scoring multiple SNPs

Processing the variants from the 1000 Genomes project resulted in scoring 67,109 SNP sets. A SNP set may be formed from different transcripts, which results in multiple scores for a set (there are 91,970 set scores in total). For a SNP set and transcript pair, HMMvar measures the deleterious effect of the SNP set using the original transcript as the wild type sequence. 291,662 single variants from those SNP sets were gathered and scored. The mean set score distribution is significantly different from the single variant score distribution (one-tailed Wilcoxon rank-sum test, p<2.2×10−16). One thousand SNP set scores and 1000 single SNP scores are repeatedly sampled from 91,970 set scores and 275,840 single SNP scores. The cumulative distribution functions of the means of the set scores and single scores are shown in Fig. 2. The SNP sets are more likely to be scored higher than those of single SNPs. The density of SNP set scores tend to be higher than the density for individual SNP scores on both ends.

Fig. 2
figure 2

Comparison between variant set score (black) and single variant score (red)

Let V = {v 1,v 2,…,v n } be a set of variants v i (1≤in), S denote the HMMvar score of the set V, and s 1, s 2, …, s n be the corresponding single variant scores of v 1, v 2, …, v n , respectively. Define V as a compensatory mutation (CM) set if S≤ min{s 1,s 2,…,s n }−1.5(max{s 1,s 2,…,s n }− min{s 1,s 2,…,s n }). One hundred eighteen CM sets were obtained from the data set. The CM sets indicate that the deleterious effect of a single variant is compensated by combining it with other variants.

Define V as a noncompensatory mutation (nonCM) set if S≥ max{s 1,s 2,…,s n }+1.5(max{s 1,s 2,…,s n }− min{s 1,s 2,…,s n }). Two thousand three hundred ninety-two nonCM sets were obtained from the data set. The nonCM sets indicate the joint effect of multiple neutral variants could possibly result in deleterious effect.

To investigate the single variants in the CM and nonCM sets, all the single variants from all the CM sets and all the nonCM sets are gathered, respectively. The allele frequency distributions from these two groups are compared in Fig. 3. When the allele frequency is less than 0.1, the proportion of the nonCM variants is greater than that of the CM variants. This is probably because the single variants are so deleterious that in most of cases, the joint effect of these deleterious variants is still deleterious. However, when the allele frequency is in the range of 0.1 to 0.3, the signal of the compensatory mutation effect is boosted.

Fig. 3
figure 3

Allele frequency distribution of SNP variants in CM sets and nonCM sets

As a test case for HMMvar’s capability in predicting the effect of multiple variants compared to the effect of single variants, the multiple mutations that have been shown to increase the severity of cardiovascular disease from single mutations are scored, in β-myosin heavy chain (MHC) and myosin-binding protein C (MyBP-C) genes. Studies have shown that single mutations in these two genes can lead to genetic cardiovascular disease, and multiple mutations on these same genes can lead to more severe cardiovascular disorders and even death [17]. As shown in Table 3 for both genes, compound mutations all have higher HMMvar scores than single mutations, consistent with the notion that compound mutations in these genes cause more severe cardiovascular disease than single mutations. The set score effectively reflects the cumulative effects of the single mutations. The maximum score for compound missense mutations in the βMHC gene is the combination of Arg719Trp and Met349Thr, which has been reported causing sudden death [17].

Table 3 Scoring multiple mutations in β MHC and MyBP-C genes

Scoring compensatory indels

From TP53, 850 variants were found that met the criterion for belonging to a compensatory indel set, out of 3565 variants. The deleterious functional effects caused by these variants can be greatly weakened by compensatory indels as measured by HMMvar scores. There may be different compensatory indel sets for a given single variant due to different combinations. Figure 4 a shows the HMMvar score of a single variant versus the median of the HMMvar scores of the corresponding compensatory indel sets. It is obvious that most of the deleterious variants (high HMMvar scores) are neutralized by the compensatory indel sets (low HMMvar scores ≈1).

Fig. 4
figure 4

Scatter plot of HMMvar score of a single variant versus the median HMMvar score of the corresponding compensatory indel sets for the TP53 gene and the PTEN gene. The red line is y=x. a TP53 compensatory indels. b PTEN compensatory indels. The red solid circle marks the COSMIC variant with ID 428080

PTEN is also an intensively studied tumor suppressor gene. Figure 4 b shows the HMMvar score of 246 variants versus the median HMMvar score of the corresponding compensatory indel sets, which shows the same trend as the TP53 variants. This scoring procedure provides candidate compensatory indel sets, which when substituted for the indel, ameliorate the deleterious effect of that single mutation. For instance, the deleterious variant c.142delA (COSMIC428080) associated with skin cancer [18] has HMMvar score 1.75; however, with compensatory indels, the deleterious effect can be lessened to a HMMvar score of 1.07. At the same time, the results here demonstrate the importance of scoring multiple variants together, instead of individually, to understand their joint effect.

Discussion

A single mutation, if not detrimental, can still exist in populations with low frequency. Over time, other mutations can also occur and thus multiple mutations can accumulate on the same gene. Compared to individual mutations, multiple mutations can be either more deleterious or less deleterious, the latter being known as compensatory mutation. Although it is not known which scenario is more prevalent in evolution, both scenarios have ample literature. Multiple mutations on the same gene, also called compound mutations, have been found to contribute or be linked to various genetic diseases (cf. [1921]). In fact, a recent survey [17] of genetic cardiovascular disease led the authors to propose that multiple mutations, as opposed to single mutations, can be used as the genetic marker for the severity of cardiovascular disease, illustrating the importance of taking into account multiple mutations in disease outcome predictions. However, the current algorithms for predicting variant effect are limited to a single variant, a SNP or an indel. To fill this research gap, the present work proposes extending HMMvar, a hidden Markov model-based scoring method [11], to predict the effect of any number of mutations in any combinations (i.e., SNPs and/or indels).

Results show that multiple mutations do tend to have different effects on genes compared to single mutations, as reflected by the significant difference in the distributions of the HMMvar scores (one-tailed Wilcoxon rank-sum test, p<2.2×10−16). The HMMvar scores of multiple SNPs tend to be larger than those of single SNPs, suggesting that many of these multiple mutations exacerbate the deleterious effect of single mutations. Note that while scoring the SNPs discovered in the 1000 Genomes project, the scored variants are identified by the next-generation sequencing (NGS) data where short sequences are generated and compared to the human reference genome to identify variants. Therefore, the genotype of the mutant individual is unknown, as is whether multiple mutations exist on the same allele or different alleles. To circumvent this problem, only those variants that are in homozygous state are scored. Figure 5 shows the zygosity of disease-causing mutations or any mutations in general. Single variants could be in a heterozygous (a) or homozygous (b) state. For multiple variants on the same gene (Fig. 5 ce shows two mutations as an example), there are three possible scenarios: trans compound heterozygous (c), cis compound heterozygous (d), or compound homozygous (e). This study scored compound mutations as scenario (e), so the two mutations are linked on the same allele. Homozygous mutations, single or multiple, cannot be detrimental as individuals with them in homozygous state will not be able to survive.

Fig. 5
figure 5

Zygosity of disease-causing single (ab) or multiple mutations (ce). The cross and circle indicate different mutations; the different thicknesses indicate different alleles of a mutation, and the thicker one indicates a disease-causing allele; the boxes represent a gene

When multiple mutations occur and accumulate on the same gene, it is possible that though deleterious by themselves, they come together and become less deleterious or even beneficial to the carrier due to either recovery of the original gene function or gain of new function. This type of mutation, known as compensatory mutation, has been documented in the literature with many of the cases found in bacteria and viruses [2224]. Potential compensatory indels were identified in two tumor suppressor genes, TP53 and PTEN, where compensatory indels are composed of frameshift indels that can recover the original reading frame. Results show that the HMMvar scores for the effect of compensatory indels are indeed much lower than the scores of the frameshift indels, with many of them close to one (Fig. 4), suggesting that compensatory indels can rescue the deleterious effect of frameshift indels. Similarly, Fig. 3 shows that SNPs with putative compensatory effect (CM) tend to have higher frequencies in the 1000 Genomes data than those SNPs predicted to be noncompensatory (nonCM, Fig. 3).

HMMvar can predict the effect of a set of multiple variants in its entirety. This is especially useful when multiple variants occur in a protein, each of which may have deleterious effects on the protein function, but the combination of them may be less deleterious due to a compensatory effect. Profile HMMs, used as proposed, have the capability to predict the joint effect of multiple mutations along the gene given a specific haplotype. Due to current technological limitations, inferring genotypes of a gene is still a challenge and little data exists that can be used for understanding the effect of multiple variations on the same gene. With future sequencing technology, long sequences may be generated and genotypes of a gene may be determined with certainty, in which case the HMMvar method will be of great use in understanding the joint impact of multiple mutations, in addition to single mutations, and better identification of disease contributing/causing variations.

References

  1. Cooper G, Shendure J. Needles in stacks of needles: finding disease-causal variants in a wealth of genomic data. Nat Rev Genet. 2011; 12:628–40.

    Article  CAS  PubMed  Google Scholar 

  2. Pauline C, Henikoff S. Predicting deleterious amino acid substitutions. Genome Res. 2011; 11:863–74.

    Google Scholar 

  3. Ramensky V, Bork P, Sunyaev S. Human non-synonymous snps: server and survey. Nucleic Acids Res. 2002; 30:3894–900.

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  4. Zia A, Moses A. Ranking insertion, deletion and nonsense mutations based on their effect on genetic information. BMC Bioinformatics. 2011; 12:299.

    Article  PubMed Central  PubMed  Google Scholar 

  5. Hu J, Pauline C. Predicting the effects of frame shifting indels. Genome Biol. 2012; 13:2.

    Article  Google Scholar 

  6. Choi Y, Sims G, Murphy S. Predicting the functional effect of amino acid substitutions and indels. PLoS ONE. 2012; 7:10.

    Google Scholar 

  7. Loeb KR, Loeb LA. Significance of multiple mutations in cancer. Carcinogenesis. 2000; 21(3):379–85.

    Article  CAS  PubMed  Google Scholar 

  8. Chang WC, Fang YY, Chang HW1, Chuang LY, Lin YD, Hou MF, et al. Identifying association model for single-nucleotide polymorphisms of orai1 gene for breast cancer. Cancer Cell Int. 2014; 14:29.

    Article  PubMed Central  PubMed  Google Scholar 

  9. Zetterberg H, Regland B, Palmer M, Ricksten A, Palmqvist L, Rymo, L, et al.Increased frequency of combined methylenetetrahydrofolate reductase c677t and a1298c mutated alleles in spontaneously aborted embryos. Eur J Hum Genet. 2002; 10:113–8.

    Article  CAS  PubMed  Google Scholar 

  10. Brown NM, Pratt VM, Buller A, Pike-Buchanan L, Redman JB, Sun W, et al. Detection of 677ct/1298ac “double variant” chromosomes: implications for interpretation of mthfr genotyping results. Genet Med. 2005; 7:278–82.

    Article  CAS  PubMed  Google Scholar 

  11. Liu M, Watson LT, Zhang L. Quantitative prediction of the effect of genetic variation using hidden Markov models. BMC Bioinformatics. 2014; 15:5.

    Article  PubMed Central  PubMed  Google Scholar 

  12. Petitjean A, Mathe E, Kato S, Ishioka C, Tavtigian SV, Hainaut P, et al. Impact of mutant p53 functional properties on tp53 mutation patterns and tumor phenotype: lessons from recent developments in the iarc tp53 database. Hum Mutat. 2007; 28:622–9.

    Article  CAS  PubMed  Google Scholar 

  13. Forbes SA, Bindal N, Bamford S, Cole C, Kok CY, Beare D, et al. Cosmic: mining complete cancer genomes in the catalogue of somatic mutations in cancer. Nucleic Acids Res. 2010; 39:945–50.

    Article  Google Scholar 

  14. Williams LE, Wernegreen JJ. Sequence context of indelmutations and their effect on protein evolution in a bacterial endosymbiont. Bioinformatics. 2013; 5:599–605.

    Google Scholar 

  15. Martello S, Toth P. 4 subset-sum problem. In: Knapsack problems: algorithms and computer interpretations. Chichester: Wiley Interscience: 1990. p. 105–36.

    Google Scholar 

  16. Eddy S. Profile hidden markov models. Bioinformatics. 1998; 14:755–63.

    Article  CAS  PubMed  Google Scholar 

  17. Kelly M, Seminarian C. Multiple mutations in genetic cardiovascular disease a marker of disease severity?Circ Cardiovasc Genet. 2009; 2:182–90.

    Article  CAS  PubMed  Google Scholar 

  18. Konopka B, Paszko Z, Janiec-Jankowska A, Goluda M. Assessment of the quality and frequency of mutations occurrence in pten gene in endometrial carcinomas and hyperplasias. Cancer Lett. 2002; 178:43–51.

    Article  CAS  PubMed  Google Scholar 

  19. Kamphans T, Sabri P, Zhu N, Heinrich V, Mundlos S, Robinson PN, et al. Filtering for compound heterozygous sequence variants in non-consanguineous pedigrees. PLOS ONE. 2013; 8:70151.

    Article  Google Scholar 

  20. Rafi MA, Coppola S, Liu SL, Rao HZ, Wenger DA. Disease-causing mutations in cis with the common arylsulfatase a pseudodeficiency allele compound the difficulties in accurately identifying patients and carriers of metachromatic leukodystrophy. Mol Genet Metab. 2013; 79(2):83–90.

    Google Scholar 

  21. Carlsen BC, Meldgaard M, Johansen JD, Thyssen JP, Menne T, Szecsi PB, et al. Filaggrin compound heterozygous patients carry mutations in trans position. Exp Dermatol. 2013; 22(9):572–5.

    Article  CAS  PubMed  Google Scholar 

  22. Wu NC, Young AP, Dandekar S. Systematic identification of h274y compensatory mutations in influenza a virus neuraminidase by high-throughput screening. J Virol. 2013; 87(2):1193–1199.

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  23. Poon A, Chaom L. The rate of compensatory mutation in the dna bacteriophage ϕx174. Genetics. 2005; 170(3):989–99.

    Article  CAS  PubMed Central  PubMed  Google Scholar 

  24. Gonzalez-Ortega E, Ballana E, Badia R, Clotet B, Este JA. Compensatory mutations rescue the virus replicative capacity of virip-resistant hiv-1. Antivir Res. 2011; 92(3):479–83.

    Article  CAS  PubMed  Google Scholar 

Download references

Acknowledgements

The work was partially supported by NIH grant AI085091 to Zhang. We thank Tony Reiter for the technical support for constructing the website. This article is partially supported by Virginia Tech’s Open Access Subvention Fund.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Liqing Zhang.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors’ contributions

ML, LTW, and LZ wrote the paper. ML performed the computational experiments. LTW proposed the HMMvar D and O scores. LZ proposed the use of HMMs for variant effect prediction. 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

Liu, M., Watson, L.T. & Zhang, L. Predicting the combined effect of multiple genetic variants. Hum Genomics 9, 18 (2015). https://doi.org/10.1186/s40246-015-0040-4

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s40246-015-0040-4

Keywords