Abstract
Specific selection pressures often lead to specifically mutated genomes. The open source software SeqFeatR has been developed to identify associations between mutation patterns in biological sequences and specific selection pressures (“features”). For instance, SeqFeatR has been used to discover in viral protein sequences new T cell epitopes for hosts of given HLA types. SeqFeatR supports frequentist and Bayesian methods for the discovery of statistical sequence-feature associations. Moreover, it offers novel ways to visualize results of the statistical analyses and to relate them to further properties. In this article we demonstrate various functions of SeqFeatR with real data. The most frequently used set of functions is also provided by a web server. SeqFeatR is implemented as R package and freely available from the R archive CRAN (http://cran.r-project.org/web/packages/SeqFeatR/index.html). The package includes a tutorial vignette. The software is distributed under the GNU General Public License (version 3 or later). The web server URL is https://seqfeatr.zmb.uni-due.de.
Introduction
There is a widening gap between the surge of information rich sequence data, and the human resources available for analysis. This is a problem that severely hampers progress in biomedicine and other life sciences [1, 2]. Ideally, experimental or clinical researchers who are most familiar with and interested in their data should be enabled to analyze their data by themselves. While software for statistics and graphics, such as R [3] (http://www.R-project.org/), are freely available and well-suited for such analyses, the steep slope of the learning curve is often discouraging experimental and clinical researchers, who are fully occupied with managing experiments or clinical duties. A general and relevant field where this disparity has been expressed to the authors by clinical researchers, especially immunologists and virologists, is the association of features of clinical interest with sequences. A concrete example is the association of patients’ HLA (Human Leukocyte Antigen) types with substitutions in a viral protein sequenced from these patients, as a way of identifying T-cell epitopes and immune escape mutations [4]. There are powerful computational tools for the identification of associations between sequences and features, for instance in the domain of genome wide association studies [5], or next-generation sequencing exome or genome comparisons [6, 7], but these tools are optimized for specific application scenarios and not for ease of use in experimental or clinical laboratory settings.
We have developed the R-package SeqFeatR to allow experimental and clinical researchers easier access to the statistical and graphical capabilities of R for feature-sequence association studies. R was chosen since it is a powerful, free, open source suite that is available for all commonly used computing platforms.
SeqFeatR has been successfully introduced in several virological labs, and sequence-feature associations identified with SeqFeatR have been experimentally confirmed, as in the case of novel CD8+ T-cell epitopes in HCV [8], or compensatory substitutions outside such epitopes [9].
These published examples have used the feature “HLA type” and amino acid sequences. However, SeqFeatR is completely agnostic about the type of feature used, as long as it can be labeled unequivocally, and it also processes nucleotide sequences. Both will be demonstrated in section “Examples beyond HLA-sequence association”.
Core functionality of SeqFeatR
Given a set of related nucleotide or amino acid sequences, such as variants of a gene from several patients with certain phenotypes, SeqFeatR discovers in those sequences positions that are statistically associated with a “feature”, for instance with one of the patient phenotypes. An example of a feature of great clinical importance is the HLA type of a patient. In a patient infected with highly variable virus, such as HIV, HCV, or HBV, the HLA system of that patient selects viral variants with immune escape mutations. Thus we can expect that mutations in viral genome sequences are associated with the patient feature “HLA type”. SeqFeatR detects such associations, in other words: it finds among all alignment positions those that have a statistically significant association with a given feature. Analogous to the association of single alignment positions vs. features, SeqFeatR allows for the screening of associations of position pairs or tuples with sequence features, though at higher computational cost.
Technically, SeqFeatR reads FASTA formatted multiple sequence alignments, with each sequence labeled in its header line with the name of the feature, for instance the HLA type of the patient from whom the respective viral sequence has been extracted. The alignment should contain sequences that are positive for the feature of interest, and sequences that are negative. SeqFeatR steps through all alignment columns and applies frequentist or Bayesian methods to detect associations with the feature.
SeqFeatR itself does not implement alignment functionality, since there are many excellent programs for multiple sequence alignments that can be used to turn sequence sets into multiple sequence alignments, for instance MAFFT [10], T-Coffee [11], or Clustal omega [12].
Frequentist approach
In the frequentist approach used in SeqFeatR, Fisher’s exact tests [13] are applied to contingency tables for all letters of the relevant alphabet (amino acid or nucleic acids) at all alignment positions vs. sequence features. This most frequently requested type of analysis is fast and also provided by the SeqFeatR web server. Logarithmically scaled p values are plotted along the alignment with single position resolution (Manhattan plots), or averaged over epitope sized windows. These association analyses are potentially affected by high numbers of false positives due to multiple testing. Therefore, SeqFeatR offers methods for multiple testing corrections, from the very conservative Bonferroni correction to the more relaxed control of False Discovery Rates (FDRs) [14].
Beyond Manhattan plots, SeqFeatR provides some novel visualization tools for advanced exploratory analyses, for instance an odds-ratio plot that simultaneously shows, along a sequence, odds-ratios and p values as two aspects of association strength (Fig 1A). Another new visualization tool is the “Tartan plot” for a synopsis of two arbitrary scalar measures of sequence position pair association, e.g. (in Fig 1B) − log p from statistical association testing of amino acids at each pair (i, j) of alignment positions vs. the Direct Information between i, j [15, 16]. The synoptic plotting quickly reveals structure in such data, such as in Fig 1B the strong association of V1/V2 loops of HIV-1 gp120 protein with the other variable loops and parts of gp41, both in terms of p values from amino acid pair-association tests, and the more refined Direct Information.
Bayesian approaches
While the frequentist approach works well in many cases, it has also drawn criticism, for instance because p values are often abused or misinterpreted [18]. Another problem with the frequentist approach occurs in situations where the same test is applied to multiple hypotheses, such as testing for associations with phenotype features for all positions in a multiple sequence alignment. As mentioned before, it is customary to “correct” the p values, e.g. by the very conservative Bonferroni correction or other more liberal alternatives, to avoid an increasing number of false positive tests results. As a more consistent alternative to deal with these problems, SeqFeatR offers also Bayesian inference methods [19], namely Bayes factors (BFs) and hierarchical models (though these are posing other problems, such as the necessity to specify priors). In the following we describe the implemented BF approach. For the hierarchical models we only mention that the SeqFeatR R-package has an interface to the Gibbs sampling engine JAGS [20]; a detailed account of hierarchical models for sequence feature association analyses will be given in a separate publication.
The BF for two hypotheses H0 and H1, given sequence and feature data D, is the ratio of posterior odds and the corresponding prior odds: BF = (p(H1|D)/p(H0|D))/(π1/π0). In other words, the BF equals the posterior odds ratio if the prior probabilities π0, π1 are equal and thus the prior odds ratio is 1. In our case H1 is the hypothesis that a feature is associated with an amino acid or nucleotide at an alignment position, and H0 is the hypothesis that there is no such association. The higher the BF, the more likely H1 (association) and the less likely H0 (no association). If the prior probability of association π1 is known, the ratio of posterior probabilities of association over non-association can be computed as BF ⋅ π1/(1 − π1).
Here we use a BF for the hypothesis H1 that feature and amino acid at an alignment position are close to independence vs. H0 that they are independent. A model H1 close to independence will often be more relevant than a “uniform model” that, for instance, assumes a uniform distribution of contingency table cell probabilities. Albert et al. have derived a BF expression for the ratio of a close-to-independence model over an independent model based on Dirichlet distributed elements of contingency tables [21, 22]:
(1) |
where yrc are the observed contingency table counts with row index r and column index c; is the Dirichlet distribution of probabilities pi (here: probabilities of contingency table elements) with normalizing multinomial Beta function B and concentration parameters αi; yr, yc are the row and column sums of the observed contingency table; K is a precision hyperparameter; ηr, ηc are hyperparameters corresponding to probabilities of row r and column c of tables with row-column independence. Curly brackets indicate that we have sets of two or more parameters. For instance, in the case of a 2 × 2 contingency table (amino acid present or absent at an alignment position versus feature present or absent), the Dirichlet distributions in the integrand depend on four parameters (two columns, two rows) and the integration therefore runs over four parameters. The prior belief in the independence is expressed by K: the higher this hyperparameter, the more dominant the independence structure imposed by ηr ηc will be in comparison to the observed counts yrc in the numerator of Eq (1), and for K → ∞ complete independence is achieved. The BF is computed numerically as an average by importance sampling of Eq (1) using ηr, ηc values that are randomly drawn from a Dirichlet distribution with concentration parameters evaluated from the entries yrc of the observed contingency table. The procedure is detailed in Ref. [23]. BFK({yrc}) is reported by SeqFeatR.
While SeqFeatR allows for setting an explicit K value, it may not be easy to specify an appropriate value of K that is applicable to all alignment positions. In such cases, a new empirical Bayes variant of this BF is convenient. In this variant, an individual value of K is estimated from each contingency table itself. To derive this value, we first acknowledge that the sum S of absolute values of differences between the actually observed counts in the contingency table and the counts expected under independence is a measure of how confident we are that columns and rows are dependent:
(2) |
with total table count N = ∑rc yrc. Clearly, for perfectly independent rows and columns, the value of S reaches its minimum of zero. The maximum of S = N is attained for strong dependence of rows and columns, for instance for a 2 × 2 table with y11 = y22 = N/2 = n and y12 = y21 = 0. To recast S into a measure of prior belief in independence we use as precision hyperparameter in Eq (1) instead of K the difference KD:
(3) |
A simple interpretation of KD is that if all N counts in the contingency table support independence, we have S = 0 and therefore KD = N (maximum prior belief in independence), while if all counts support association, we have S = N and therefore KD = 0 (minimum prior belief in independence). SeqFeatR also offers the option of using KD.
Fig 2 shows that for contingency tables for which independence cannot be rejected as indicated by p ≈ 1 from Fisher’s exact test (lower right corner), KD and K100 yield approximately the same BF ≈ 1, i.e. association and independence are given approximately equal weights. In this corner, the uniform model and even more so the model with low confidence in independence (K = 1) have BFs much closer to zero, both favoring independence over dependence. At the other end of the p value range, on the left side of the plot, the low p values lead to rejection of independence, and concordant with this, high BFs that favor association over independence. Here, the increase of BFs in the KD model follows those of lower K models. Effectively, the KD model suppresses noise by collapsing weak-association cases to BF ≈ 1 (similar to high K models), while it readily supports stronger associations (similar to low K or uniform models).
Comparison of frequentist and Bayesian approaches for discovery of HLA escape substitutions
Recently, we have reported the discovery and experimental confirmation of several HLA escape substitutions in Hepatitis B Virus (HBV) from chronically infected patients [24] (sequences available from GenBank, accession numbers KP856971-KP857118). In that report, we had used SeqFeatR with the frequentist approach for the discovery. In Fig 3 we compare the latter approach (without correction for multiple testing) and Bayes factors with precision hyperparameters K = 1 and KD. For this comparison, we have chosen two significant associations identified in Ref. [24], namely the strongest (alignment position 66 with HLA type A*01, corresponding to position 38 of HBV core protein reference) and the weakest (alignment position 96 with HLA type B*44, corresponding to position 67 of HBV core protein reference).
For all three analyses of the association with HLA A*01, alignment position 66 clearly sticks out with extremely small p value and high values of BFK = 1, and BFKD (top row of Fig 3). A frequentist would not seriously consider any other position as associated with this HLA, and most of the positions have p ≈ 1. For K = 1 we have a wide spread around BF = 1, or log10 BF = 0. Two BFs other than at position 66 lie slightly above BF = 10 (or log10 BF = 1), a threshold often used to mark “substantial” evidence [25]. However, in contrast to the BF at position 66, these two BFs are not clearly separated from the bulk of the other BFs. Towards lower BFs, many values reach down to 10−2 or lower, indicating preference for independence over association at these alignment positions. For KD we see the noise suppression mentioned earlier as the spread of the low BFs is constrained to a much smaller range than for K = 1.
For feature HLA B*44 we had only about 21 sequences (compared to 41 for HLA*A01), leading to a weaker association signal (bottom row of Fig 3). Still, the frequentist analysis shows position 96 with a p value that is clearly separated from the rest (panel D). However, a Bonferroni correction collapses all p values to 1, while the FDR correction collapses all to 1, except for position 96 with a corrected value of 0.16 (S1 Fig). The BFs with K = 1 do not favor association at any position (panel E). Conversely, for KD position 96 has a clearly elevated BF (panel F). In summary, the frequentist approach with a strict correction for multiple comparisons, or the BF approach with K = 1 would both have led to a missing of the experimentally validated association at position 96, while the frequentist approach without correction, or BFKD both identify this association.
Detection of phylogenetic bias
Sequences analyzed with SeqFeatR can often be considered samples from different branches of the same phylogenetic tree, evolved from a common ancestor under selection pressure related to the “feature”. A good example are again viral genome sequences evolved under selection pressure by the HLA systems (= features) of infected persons [8, 9, 24]. Under these circumstances, it is possible that SeqFeatR reports apparent sequence-feature associations that are due to a phylogenetic bias in the data. For instance, consider transmission of a virus from a mother to several children, all having the same HLA type. In this case, not only HLA escape mutations of viral proteins are associated with this HLA type, but apparently also mutations specific to the founder virus of the mother that are transmitted to the children, but unrelated to the HLA type. A mutation of a viral protein that is really associated with HLA type should co-occur with the HLA in other parts of the phylogenetic tree (i.e. outside this mother-child transmission), while this repeated co-occurrence is less likely for mutations that, due to phylogenetic bias, are only apparently associated with HLA.
SeqFeatR computes a simple quantitative indicator B of the strength of the phylogenetic bias for a given feature as follows. We expect that a phylogenetic bias is likely, if evolutionary distances within the group of sequences that carry the feature are much smaller than typical evolutionary distances in the total set of analyzed sequences. Thus, we define B as
(4) |
where dij is the Levenshtein distance between sequences i and j. The ratio gives the mean distance between sequences carrying the feature over the mean distance in the total sequence sample. B lies then between values that typically are close to zero or even become negative for low bias, and a maximum of 1 for the strongest bias. For instance, in Fig 4E, feature-carrying sequences are spread out over different parts of the phylogenetic tree of all sequences in the sample, and consistent with this B = 0.05 signals low bias. Conversely, in Fig 4B feature-carrying leaves are concentrated in a sub-tree, and B = 0.26 indicates higher bias.
If detection of specific substitutions is desired that are associated with the feature, and not due to phylogenetic bias, a high B suggests extension of the set of sequences, especially with evolutionarily less closely related sequences that carry the feature.
Examples beyond HLA-sequence association: HIV-1 co-receptor tropism and genetic species differences
In the above examples we have focused on the HLA type as feature and amino acid sequences. However, SeqFeatR is agnostic about the type of feature and sequence and therefore can be applied to other features and nucleotide sequences, too. To illustrate this we give in the following two examples.
HIV-1 co-receptor tropism
The Human Immunodeficiency Virus 1 (HIV-1) enters cells after contact with the cellular receptor CD4 and one of two co-receptors, either CCR5 or CXCR4 [26]. The choice of the co-receptor (or “co-receptor tropism”) is encoded in the viral genome, specifically in the third variable loop (V3) of the viral glycoprotein 120 [27]. Since the co-receptor tropism has implications for prognosis [28] and therapy [29], its determination from V3 sequence has attracted a lot of interest. Here we demonstrate that SeqFeatR recovers V3 sequence patterns known to be associated with co-receptor tropism.
To simplify the alignment, we used only V3 sequences of 35 amino acids (S1 Alignment), the by far most frequent length, from a dataset published earlier [30]. This led to 84 V3 sequences of CXCR4-tropic virus and 928 V3 sequences of CCR5-tropic virus. We then applied SeqFeatR with co-receptor tropism as feature. The resulting Manhattan plot (S2 Fig) shows many positions with highly significant deviations between CXCR4- and CCR5-tropic virus. One of the patterns recognized early on as specific for CXCR4 is the occurrence of positively charged amino acids at positions 11 and 25, the so-called 11/25 rule [31]. In fact, in the SeqFeatR output both positions 11 and 25 have significant deviations between CXCR4- and CCR5-tropic virus with p-values less than 10−4. Inspection of the alignment confirms that in CXCR4-tropic virus both positions 11 and 25 are significantly enriched in positively charged amino acids Arginine and Lysine in comparison to CCR5-tropic virus.
Genetic species differences
SeqFeatR can be used to discover genetic differences between species or other taxonomic levels. For the following example we have retrieved from the SILVA database [32], version 123, RNA sequences of the small ribosomal subunit (SSU) of two closely related green algae, Chlamydomonas applanata (9 sequences) and Chlamydomonas reinhardtii (10 sequences). The input alignment is provided as S2 Alignment. Using these two species as features, we found with SeqFeatR 29 positions with highly significant differences (red stars in Manhattan plot S3 Fig). Nucleotide sequence differences such as these can be used to understand genetic bases of species differences or to design species specific PCR primers [33].
SeqFeatR addresses various needs and levels of expertise
SeqFeatR has three modes of use, addressing users with different levels of expertise and different needs: For users not versed in R programming and with sequence material and features that can be transmitted over the Internet, we offer the SeqFeatR web server. For reproducibility and documentation, the web server generates a detailed report for the user. If the data must not leave the respective institution, inexperienced users may still use a simple Tcl/Tk-based graphical user interface (GUI) that can be started by the SeqFeatR_GUI() command from R. Experienced users can access the full range of SeqFeatR commands in R-scripts. Training material such as tutorial texts (https://cran.r-project.org/web/packages/SeqFeatR/vignettes/SeqFeatR_tutorial.pdf) and videos are provided for users at all levels.
Supporting Information
Acknowledgments
We thank Michael Michalski for technical assistance with the web server.
Data Availability
HBV sequences are available from GenBank (accession numbers KP856971-KP857118).
Funding Statement
Funding for this work was provided by Deutsche Forschungsgemeinschaft (http://www.dfg.de), grant TRR 60 / B1 to JT and DH. The funders had no role in study design, data collection and analysis, decision to publish, or preparation of the manuscript.
References
- 1. Schmidt C. Cancer: Reshaping the cancer clinic. Nature. 2015. November;527(7576):S10–S11. Available from: 10.1038/527S10a [DOI] [PubMed] [Google Scholar]
- 2. Chute CG, Ullman-Cullere M, Wood GM, Lin SM, He M, Pathak J. Some experiences and opportunities for big data in translational research. Genet Med. 2013; 15:802–809. Available from: http://www.ncbi.nlm.nih.gov/pmc/articles/PMC3906918/ 10.1038/gim.2013.121 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 3.R Core Team. R: A Language and Environment for Statistical Computing. Vienna, Austria; 2015. Available from: https://www.R-project.org/
- 4. Moore CB, John M, James IR, Christiansen FT, Witt CS, Mallal SA. Evidence of HIV-1 adaptation to HLA-restricted immune responses at a population level. Science. 2002. May;296(5572):1439–43. 10.1126/science.1069660 [DOI] [PubMed] [Google Scholar]
- 5. Rentería ME, Cortes A, Medland SE. Using PLINK for Genome-Wide Association Studies (GWAS) and data analysis. Methods Mol Biol. 2013;1019:193–213. 10.1007/978-1-62703-447-0_8 [DOI] [PubMed] [Google Scholar]
- 6. Koboldt DC, Zhang Q, Larson DE, Shen D, McLellan MD, Lin L, et al. VarScan 2: somatic mutation and copy number alteration discovery in cancer by exome sequencing. Genome Res. 2012. March;22(3):568–76. 10.1101/gr.129684.111 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 7. Hansen NF, Gartner JJ, Mei L, Samuels Y, Mullikin JC. Shimmer: detection of genetic alterations in tumors using next-generation sequence data. Bioinformatics. 2013. June;29(12):1498–503. 10.1093/bioinformatics/btt183 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 8. Ruhl M, Knuschke T, Schewior K, Glavinic L, Neumann-Haefelin C, Chang DI, et al. CD8(+) T-cell response promotes evolution of hepatitis C virus nonstructural proteins. Gastroenterology. 2011. June;140(7):2064–73. 10.1053/j.gastro.2011.02.060 [DOI] [PubMed] [Google Scholar]
- 9. Ruhl M, Chhatwal P, Strathmann H, Kuntzen T, Bankwitz D, Skibbe K, et al. Escape from a dominant HLA-B*15-restricted CD8+ T cell response against hepatitis C virus requires compensatory mutations outside the epitope. J Virol. 2012. January;86(2):991–1000. 10.1128/JVI.05603-11 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 10. Katoh K, Misawa K, Kuma K, Miyata T. MAFFT: a novel method for rapid multiple sequence alignment based on fast Fourier transform. Nucleic Acids Res. 2002. July;30(14):3059–66. 10.1093/nar/gkf436 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 11. Notredame C, Higgins DG, Heringa J. T-Coffee: A novel method for fast and accurate multiple sequence alignment. J Mol Biol. 2000;302(1):205–17. 10.1006/jmbi.2000.4042 [DOI] [PubMed] [Google Scholar]
- 12. Sievers F, Higgins DG. Clustal Omega, accurate alignment of very large numbers of sequences. Methods Mol Biol. 2014;1079:105–116. Available from: 10.1007/978-1-62703-646-7_6 [DOI] [PubMed] [Google Scholar]
- 13. Fisher RA. On the Interpretation of χ2 from Contingency Tables, and the Calculation of P. Journal of the Royal Statistical Society. 1922;85(1):87–94. Available from: http://www.jstor.org/stable/2340521 10.2307/2340521 [DOI] [Google Scholar]
- 14. Benjamini Y, Hochberg Y. Controlling the False Discovery Rate: A Practical and Powerful Approach to Multiple Testing. Journal of the Royal Statistical Society Series B (Methodological). 1995;57(1):289–300. Available from: 10.2307/2346101 [DOI] [Google Scholar]
- 15. Morcos F, Pagnani A, Lunt B, Bertolino A, Marks DS, Sander C, et al. Direct-coupling analysis of residue coevolution captures native contacts across many protein families. Proc Natl Acad Sci U S A. 2011. December;108(49):E1293–301. 10.1073/pnas.1111471108 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 16. Wang Y, Rawi R, Wilms C, Heider D, Yang R, Hoffmann D. A Small Set of Succinct Signature Patterns Distinguishes Chinese and Non-Chinese HIV-1 Genomes. PLoS One. 2013;8(3):e58804 10.1371/journal.pone.0058804 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 17. Heider D, Dybowski JN, Wilms C, Hoffmann D. A simple structure-based model for the prediction of HIV-1 co-receptor tropism. BioData Min. 2014;7:14 Available from: 10.1186/1756-0381-7-14 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 18. Nuzzo R. Scientific method: statistical errors. Nature. 2014. February;506(7487):150–152. Available from: 10.1038/506150a [DOI] [PubMed] [Google Scholar]
- 19. Stephens M, Balding DJ. Bayesian statistical methods for genetic association studies. Nat Rev Genet. 2009. October;10(10):681–90. 10.1038/nrg2615 [DOI] [PubMed] [Google Scholar]
- 20.Plummer M. JAGS: A Program for Analysis of Bayesian Graphical Models Using Gibbs Sampling. In: Proceedings of the 3rd International Workshop on Distributed Statistical Computing (DSC 2003); 2003.
- 21. Albert JH, Gupta AK. Mixtures of Dirichlet Distributions and Estimation in Contingency Tables. Ann Statist. 1982. December;10(4):1261–1268. Available from: 10.1214/aos/1176345991 [DOI] [Google Scholar]
- 22. Albert JH. A bayesian test for a two-way contingency table using independence priors. Canadian Journal of Statistics. 1990;18(4):347–363. Available from: 10.2307/3315841 [DOI] [Google Scholar]
- 23. Albert J. Bayesian Computation with R. Springer Verlag; 2009. [Google Scholar]
- 24. Kefalakes H, Budeus B, Walker A, Jochum C, Hilgard G, Heinold A, et al. Adaptation of the hepatitis B virus core protein to CD8(+) T-cell selection pressure. Hepatology. 2015. February;Available from: 10.1002/hep.27771 [DOI] [PubMed] [Google Scholar]
- 25. Kass RE, Raftery AE. Bayes Factors. Journal of the American Statistical Association. 1995;90(430):773–795. Available from: http://www.tandfonline.com/doi/abs/10.1080/01621459.1995.10476572 [Google Scholar]
- 26. D’Souza MP, Harden VA. Chemokines and HIV-1 second receptors. Confluence of two fields generates optimism in AIDS research. Nat Med. 1996. December;2(12):1293–300. 10.1038/nm1296-1293 [DOI] [PubMed] [Google Scholar]
- 27. Hwang SS, Boyle TJ, Lyerly HK, Cullen BR. Identification of the envelope V3 loop as the primary determinant of cell tropism in HIV-1. Science. 1991. July;253(5015):71–4. 10.1126/science.1905842 [DOI] [PubMed] [Google Scholar]
- 28. Koot M, Keet IP, Vos AH, de Goede RE, Roos MT, Coutinho RA, et al. Structural descriptors of gp120 V3 loop for the prediction of HIV-1 coreceptor usage. Ann Intern Med. 1993. May;118(9):681–8. [DOI] [PubMed] [Google Scholar]
- 29. Dorr P, Westby M, Dobbs S, Griffin P, Irvine B, Macartney M, et al. Maraviroc (UK-427,857), a potent, orally bioavailable, and selective small-molecule inhibitor of chemokine receptor CCR5 with broad-spectrum anti-human immunodeficiency virus type 1 activity. Antimicrob Agents Chemother. 2005. November;49(11):4721–32. 10.1128/AAC.49.11.4721-4732.2005 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 30. Dybowski JN, Heider D, Hoffmann D. Prediction of co-receptor usage of HIV-1 from genotype. PLoS Comput Biol. 2010. April;6(4):e1000743 10.1371/journal.pcbi.1000743 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 31. Xiao L, Owen SM, Goldman I, Lal AA, deJong JJ, Goudsmit J, et al. CCR5 coreceptor usage of non-syncytium-inducing primary HIV-1 is independent of phylogenetically distinct global HIV-1 isolates: delineation of consensus motif in the V3 domain that predicts CCR-5 usage. Virology. 1998. January;240(1):83–92. Available from: 10.1006/viro.1997.8924 [DOI] [PubMed] [Google Scholar]
- 32. Quast C, Pruesse E, Yilmaz P, Gerken J, Schweer T, Yarza P, et al. The SILVA ribosomal RNA gene database project: improved data processing and web-based tools. Nucleic Acids Res. 2013. January;41(Database issue):D590–D596. Available from: 10.1093/nar/gks1219 [DOI] [PMC free article] [PubMed] [Google Scholar]
- 33. Epp LS, Stoof-Leichsenring KR, Trauth MH, Tiedemann R. Molecular profiling of diatom assemblages in tropical lake sediments using taxon-specific PCR and Denaturing High-Performance Liquid Chromatography (PCR-DHPLC). Mol Ecol Resour. 2011. September;11(5):842–853. Available from: 10.1111/j.1755-0998.2011.03022.x [DOI] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.
Supplementary Materials
Data Availability Statement
HBV sequences are available from GenBank (accession numbers KP856971-KP857118).