Next Article in Journal
Assessment of Immunogenicity and Neutralisation Efficacy of Viral-Vectored Vaccines Against Chikungunya Virus
Next Article in Special Issue
The Utility of Data Transformation for Alignment, De Novo Assembly and Classification of Short Read Virus Sequences
Previous Article in Journal
Subclade 2.2.1-Specific Human Monoclonal Antibodies That Recognize an Epitope in Antigenic Site A of Influenza A(H5) Virus HA Detected between 2015 and 2018
Previous Article in Special Issue
Protein Structure-Guided Hidden Markov Models (HMMs) as A Powerful Method in the Detection of Ancestral Endogenous Viral Elements
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Interpreting Viral Deep Sequencing Data with GLUE

1
MRC-University of Glasgow Centre for Virus Research, Glasgow G61 1QH, UK
2
Virus Reference Department, National Infection Service, Public Health England, Colindale, London NW9 5EQ, UK
3
Peter Medawar Building for Pathogen Research, Nuffield Department of Medicine, University of Oxford, Oxford OX1 3SY, UK
*
Author to whom correspondence should be addressed.
Viruses 2019, 11(4), 323; https://doi.org/10.3390/v11040323
Submission received: 28 February 2019 / Revised: 13 March 2019 / Accepted: 14 March 2019 / Published: 3 April 2019
(This article belongs to the Special Issue Virus Bioinformatics)

Abstract

:
Using deep sequencing technologies such as Illumina’s platform, it is possible to obtain reads from the viral RNA population revealing the viral genome diversity within a single host. A range of software tools and pipelines can transform raw deep sequencing reads into Sequence Alignment Mapping (SAM) files. We propose that interpretation tools should process these SAM files, directly translating individual reads to amino acids in order to extract statistics of interest such as the proportion of different amino acid residues at specific sites. This preserves per-read linkage between nucleotide variants at different positions within a codon location. The samReporter is a subsystem of the GLUE software toolkit which follows this direct read translation approach in its processing of SAM files. We test samReporter on a deep sequencing dataset obtained from a cohort of 241 UK HCV patients for whom prior treatment with direct-acting antivirals has failed; deep sequencing and resistance testing have been suggested to be of clinical use in this context. We compared the polymorphism interpretation results of the samReporter against an approach that does not preserve per-read linkage. We found that the samReporter was able to properly interpret the sequence data at resistance-associated locations in nine patients where the alternative approach was equivocal. In three cases, the samReporter confirmed that resistance or an atypical substitution was present at NS5A position 30. In three further cases, it confirmed that the sofosbuvir-resistant NS5B substitution S282T was absent. This suggests the direct read translation approach implemented is of value for interpreting viral deep sequencing data.

1. Introduction

For some virus species, their highly error-prone replication mechanism produces a population of related genomic variants of the virus within a single infected host individual [1]. Sequencing systems such as Illumina’s platform produce short, relatively accurate nucleotide sections of viral genome, often generating thousands of reads for a given genomic location from a single sample [2]. Such deep sequencing technologies therefore offer methods for understanding the nature of viral intra-host diversity. Whole genome and deep sequencing of virus genomes has been widely applied in basic virology research but has also found applications in clinical contexts such as the detection of drug resistance [3].
Various bioinformatics stages must be applied in the interpretation of viral deep sequencing data. Reads unrelated to the virus genome are removed and low-quality reads removed or trimmed. Following this, we must then construct an alignment: how the reads are arranged relative to each other within the virus genome, accounting for sequence homology. Reference-based alignment or mapping methods such as Bowtie 2 [4], BWA [5], MOSAIK [6], Stampy [7] or Tanoti [8] use one or more reference sequences to guide the alignment of reads. In contrast, de novo assembly approaches such as SPAdes [9] and VICUNA [10] use associations derived purely from the read data itself to propose large genome fragments, avoiding the biases arising from the choice of reference sequence. A drawback of de novo methods is that they may not accurately capture the full genomic structure or diversity, thus, for well-known viruses with high levels of genomic diversity, combinations of de novo assembly and reference-based alignment methods, such as shiver [11], are often used. One aspect common to almost all recent methods in this area is that they output their results in the form of a sequence alignment mapping (SAM) file. The SAM format [12] integrates nucleotide, read quality and alignment data in a single file. It was standardised at an early point in the adoption of deep sequencing, allowing diverse methods to be compared with each other and integrated into processing pipelines for a broad set of applications.
A range of variant-calling methods have been developed to analyse genomic heterogeneity within deep sequencing data. Error rates in short read technologies such as Illumina are low but it can be challenging to distinguish errors from real single nucleotide variants (SNVs) occurring at frequencies comparable to the error rate. Therefore, variant-calling methods such as LoFreq [13] and V-Phaser [14,15] apply statistical techniques to the aligned read data to identify probable SNVs occurring even at very low frequency in the presence of sequencing errors. The focus on low frequency SNVs is critical in applications such as cancer genomics where somatic deviations from the consensus are both rare and of high consequence [16]. However, virus bioinformatics has distinct priorities from fields focused on eukaryote or bacterial organisms with higher replication fidelity [17]. Since viruses typically have a low replication fidelity, there is a higher level of diversity within an infected host and the viral population can be expected to contain many variants.
For reasons of clarity within the research community, virus genome locations can be defined in terms of a standard virus strain with a well-established “master reference” genome. In hepatitis C virus (HCV) for example, codons within viral proteins are numbered relative to the H77 strain [18]. Polymorphisms at these standardised locations are reported with phenotypic associations established experimentally or in clinical trials. The advent of deep sequencing data prompts questions such as: What are the relative proportions of different amino acid residues at a given genome location? What proportion of reads support the presence of a certain sequence motif? What proportion of reads indicate a deletion? However, it is challenging to answer these questions within deep sequencing data, since read alignments do not in general use the reference coordinate space, and a mapping between the two spaces must be established and applied.
The genomes of the virus population may contain multiple nucleotide base variants at different positions within a single codon location. Both Verbist et al. [19] and Döring et al. [20] pointed out that linkage between nucleotide positions is lost when variants are called as SNVs. This linkage must be retained within datasets in order to accurately predict the amino acid residues arising from protein translation. Suppose for example we observe significant levels of both adenine (A) and thymine (T) at the first position of a particular codon location. At the second position, we observe cytosine (C) and guanine (G). With cytosine at the third position, what amino acids are the genomes in the virus population coding for? Without retaining linkage, these observations are consistent with a mix of Threonine (codon ACC) and Cysteine (TGC), or alternatively with purely Serine (AGC/TCC), or with any combination of these amino acids. By retaining linkage, we can accurately select between these interpretations. Haplotype reconstruction methods aim to determine linkage by associating sub-populations of reads as haplotypes. Schirmer et al. [21] found that this was exceptionally unreliable for viral deep sequencing data. However, full haplotype reconstruction may not be necessary for practical applications where the variants of interest are linked within the span of a single read or read pair.
We present a subsystem of the GLUE software package [22] called samReporter, focused on the analysis of aligned deep sequencing viral genome data. It directly processes the SAM file format produced by most methods, and can also process the more compact Binary Alignment Map (BAM) format. The samReporter can be instantiated within an existing GLUE project containing reference sequences and alignments for a given virus. This allows the software to establish a reading frame for coding region reads within a SAM file, and map between the read alignment coordinate space and standardised genome locations. In turn, this facilitates the scanning of reads directly for different classes of sequence pattern such as codons, amino acid residues, indels and motifs. This approach of scanning reads directly has the advantage of retaining linkage and we can report how often combinations of variations appear together on the same viral RNA, certainly within a codon location but also further, at least as far as paired-end read data allows.
We demonstrate the benefits of applying the GLUE samReporter to hepatitis C virus (HCV) deep sequencing data. HCV is a positive-sense single-stranded RNA virus of the family Flaviviridae. Its genome of about 9000 bases codes for a single polyprotein that produces 10 mature viral proteins. HCV affects over 100 million people worldwide and can cause liver disease and cirrhosis. The infection can be treated with a range of direct-acting antiviral (DAA) drugs which inhibit three of the mature proteins: NS3, NS5A and NS5B. Such therapies produce a sustained virological response (SVR) in the vast majority of patients, clearing the virus in around 95% of cases [23]. Notwithstanding this therapeutic success, HCV is proving difficult to treat in certain categories of patients, including “retreatment” patients: those for whom prior DAA treatment has failed. It has been shown both in vitro and in vivo that certain resistance-associated substitutions (RASs) in the viral genome confer resistance to DAA drugs [24].
Vermehren et al. suggested that retreatment patients have RASs in multiple drug target genes and that therefore “genomic resistance testing may be useful to select the optimal combination and treatment duration” for subsequent rounds of drug therapy [23]. Recent guidance suggests that, if deep sequencing is used, observing a RAS in 15% of the virus population may be clinically relevant [25]. Tools aimed at HCV resistance testing such as geno2pheno[ngs-freq] [20] suggest frequencies of 2%, 10% and 15%. Thus, while HCV RAS testing can benefit from deep sequencing methods, moderately-low rather than ultra-low frequencies are of most interest. RAS testing for retreatment patients therefore provides a good case study for a deep sequencing data interpretation system.

2. Results

We analysed viral genome diversity within a group of 241 HCV retreatment patients sampled within the United Kingdom. A range of genotypes were represented: Gt1 n = 115, Gt2 n = 5, Gt3 n = 104, Gt4 n = 14 and Gt6 n = 3. The five most frequent subtypes: were 1a n = 98, 1b n = 13, 3a n = 95, 3b n = 6 and 4r n = 6. Fourteen other subtypes were represented each by three or fewer patients. In three cases, a subtype could not be assigned.
The samReporter scans aligned reads directly, retaining linkage within reads with the intention of more accurate detection of specific variants. To test the benefits of this approach, we also contrived an alternative method that attempts to capture within-host diversity without retaining linkage.
Besides the four concrete bases A, C, G and T/U, IUPAC notation for nucleic acids, used in the FASTA sequence file format, contains 11 ambiguity codes, covering all possible combinations of more than one base [26]. For example, code S can represent a combination of C and G. Any method which calls SNVs can encode these variants within a FASTA file. This aspect of the encoding is used to capture minor nucleotide variants. Web-based HCV drug resistance interpretation systems such as HCV-GLUE [27] and geno2pheno[hcv] [28] do attempt to interpret ambiguity codes if they appear in the input data. We produced FASTA files with ambiguity codes for each sample using the samReporter nucleotide-consensus command, which produces one IUPAC code for each nucleotide position in the SAM reference coordinate space. Read bases with a Phred quality score of less than 25 were excluded. A “concrete” base (A, C, G or T) was encoded at a given position if it appeared both in at least five individual reads and in 5% of the quality-filtered reads at that location. IUPAC ambiguity codes are then used if multiple concrete bases are to be encoded. We found that FASTA files for all but two samples contained at least one ambiguity code. On average, files contained ambiguity codes which represent two bases at 1.02% of nucleotide positions (std. dev. 1.3 % ) and codes which represent three bases at 0.0161% of nucleotide positions (std. dev. 0.0475 % ).
A triplet of concrete bases, i.e., a codon, specifies a single amino acid. If ambiguity codes occur within nucleotide data for a given codon location, multiple distinct codons are present in the underlying data at that location; the precise composition is unknown. For a given ambiguous triplet (possibly containing ambiguity codes), there is set of “possible” amino acids comprising any residues coded by one or more of the possible codons. For example, for the ambiguous triplet YTM, the set of possible amino acids is Leucine (L) and Phenylalanine (F) because the set of codons and their corresponding amino acids are CTA (L), CTC (L), TTA (L) and TTC (F). Additionally, there is a (possibly empty) subset of “definite” amino acid residues, i.e., those that must be coded by at least some of the underlying codons, whatever the composition, under reasonable assumptions. For the ambiguous triplet YTM, every combination of codons which produces the ambiguity codes contains at least some codons for Leucine (L); this is the single definite amino acid. In general, if there is a single ambiguity code encoding two bases within the triplet, there will be one or two definite amino acids, and these will also be the only possible amino acids.
The FASTA files were analysed for “ambiguous” codon locations where the definite and possible amino acid sets were different. This typically occurs when there are two ambiguity codes within a triplet. Such locations present a challenge for drug resistance interpretation systems based on FASTA file inputs. Whereas amino acid residues in the definite set can be inferred to be present in the virus population, the status of amino acids in the possible set but not the definite set cannot be established clearly from FASTA data. We excluded from the analysis degenerate locations i.e., those where the possible set, excluding stops, contained more than five amino acids or where the read depth for the whole codon location was less than 10.
In total, 435 ambiguous locations were found in patients, within all ten viral proteins: Core n = 62, E1 n = 24, E2 n = 205, p7 n = 5, NS2 n = 14, NS3 n = 30, NS4A n = 1, NS4B n = 9, NS5A n = 38 and NS5B n = 47. The full set of ambiguous locations is given in the Supplementary Materials. Scaling by the length of each region, this implies that the E2 and Core proteins had a higher rate of ambiguous locations. The drug target proteins NS3, NS5A and NS5B have rates in the lower part of the range.
The current version of HCV-GLUE [27] documents 44 locations associated in the literature with resistance to six DAA drugs in current use: 18 in NS3, 15 in NS5A and 11 in NS5B. These are listed in the Supplementary Materials. Within the FASTA data, we found 10 ambiguous resistance-associated locations in nine patients, six in NS5A and four in NS5B. We resolved these locations using the GLUE samReporter, calculating the frequencies of codons and amino acids by directly analysing reads. Codons were excluded if any Phred base quality was below 25. Amino acid residues were deemed to be present if 5% or more of filtered read codons at the location coded for the residue. The 10 locations are shown in Table 1. HCV-GLUE classifies an amino acid as typical at a location for a given subtype if 10% or more of the GenBank sequences of that subtype contain the residue, these are also shown in the table. In all cases except one (R25, NS5B position 159) the definite residues set (not shown) was empty.
In the cases shown in Table 1, samReporter was able to eliminate many possible residues. Whereas the possible set contained up to four residues, samReporter confirmed that only one or two were actually present at the 5% level. Two resistance locations occur three times each and merit a discussion. For NS5A position 30, in subtype 1a the typical residue is Glutamine (Q). In sample R67, samReporter found Tyrosine (Y) at around 74%, which has not been documented as a RAS but is atypical for the subtype. In samples HCV300 and R164 (subtype 3a) the typical residue is Alanine (A); samReporter found Lysine (K), a well-documented RAS, at levels of 92% and 82% respectively. Thus, in these three cases samReporter confirmed the presence of a RAS or atypical substitution. Substitutions at NS5B position 282 have been strongly associated with resistance to sofosbuvir, particularly the substitution of the typical Serine (S) with Threonine (T). In contrast with NS5A position 30, samReporter was able to eliminate this resistant residue and the other possible atypical residue Cysteine (C); in these three ambiguous cases, only Serine is present, but is actually coded by significantly distinct codons in each case. For sample HCV294, the codons were TCT at 54%, AGT at 25% and AGC at 20%, for sample R25, AGC at 85% and TCC at 15%, and, for sample R36, TCC at 92% and AGC at 7%. The effect of the presence of these diverse codons is to create ambiguity at the nucleotide level. One possible explanation for the codon diversity is that Threonine codons became frequent in the viral population during sofosbuvir treatment, and that following the end of the treatment course the descendants of these virions reverted to Serine, but now coded using diverse alternative codons.
The HCV296 sample is typical in the sense that the size of the BAM file (24.6 MB) was closest to the mean for this dataset, it contains ≈282,000 paired-end reads with an average depth across the HCV polyprotein of ≈3700. To evaluate performance, we ran some samReporter commands on this file using a 2014 MacBook Pro with a 2.5 GHz Intel Core i7 processor and 16 GB of RAM. The samReporter was configured to use up to four CPU cores. The amino-acid command was run to translate reads for the whole polyprotein, producing amino acid residue frequencies at each codon location, without any read filters. Using the auto-align feature with a known target reference sequence, this command took 7.5 s. Using the max-likelihood-placer feature, the command took 29.2 s, with most of the extra time spent in the RAxML-EPA step. See Section 3.2 for details of the samReporter design.

3. Materials and Methods

3.1. Sequencing Data

Deep whole genome HCV sequencing data was derived from blood samples collected from 241 patients resident in the United Kingdom, who had not achieved virological clearance after previous courses of antiviral therapy. Sequencing was performed using target enrichment on Illumina sequencers at three different institutes: the MRC-University of Glasgow Centre for Virus Research (n = 56), the University of Oxford Nuffield Department of Medicine (n = 25) and the Virus Reference Department at Public Health England (PHE) (n = 160).
The Glasgow library preparation protocol was as follows. RNA was isolated from 200 μ L of plasma using the RNAdvance Blood extraction kit (Beckman Coulter, Brea, CA, United States) and collected in 27 μ L of water. Following conversion of RNA to double-stranded DNA, libraries were prepared for Illumina sequencing using the KAPA DNA LTP Library Preparation Kit (Roche, Basel, Switzerland), and NEBNext Multiplex Oligos for Illumina (New England Biolabs, Ipswich, MA, United States). Libraries were quantified using Qubit dsDNA HS Assay Kit (Invitrogen, Carlsbad, CA, United States) and size distribution assessed using Agilent TapeStation with D1K High Sensitivity Kit (Agilent, Santa Clara, CA, United States); libraries were normalised according to viral load and mass. A 500 ng aliquot of the pooled library was enriched using SeqCap EZ Developer Probes (Roche), following the manufacturer’s protocol. Following a 14 cycle post-enrichment PCR, the cleaned pool was sequenced with 151-base paired-end reads on a NextSeq cartridge (Illumina, San Diego, CA, United States).
The Oxford libraries were prepared for Illumina sequencing using the NEBNext Ultra Directional RNA Library Prep Kit (New England Biolabs) with 8  μ L of RNA extracted from plasma using NUCLISENS easyMAG (bioMérieux, Marcy-l’Étoile, France) and previously published modifications of the manufacturer’s guidelines (v2.0) [29]: omission of heat fragmentation, omission of Actinomycin D at first-strand reverse transcription, library amplification for 15 PCR cycles using custom indexed primers [30], and post-PCR clean-up with 0.85x volume Ampure XP (Beckman Coulter). Libraries were quantified using Quant-iT PicoGreen dsDNA Assay Kit (Invitrogen) and size distribution analysed using Agilent TapeStation D1K High Sensitivity kit. A 500 ng aliquot of the pooled libraries (96 plex) was enriched using the xGen Lockdown protocol (Rapid Protocol for DNA Probe Hybridization and Target Capture Using an Illumina TruSeq or Ion Torrent Library v1.0, Integrated DNA Technologies, Coralville, IA, United States) with equimolar-pooled 120 nt DNA oligonucleotide probes (Integrated DNA Technologies) followed by a 12-cycle on-bead post-enrichment PCR. The cleaned post-enrichment ve-Seq library was quantified by qPCR with the KAPA SYBR FAST qPCR Kit (Roche) and sequenced with 150b paired-end reads on a single run of the Illumina MiSeq.
The PHE library preparation protocol is the laboratory component of a pipeline aimed at clinical use; a manuscript describing the full pipeline is in preparation. RNA was extracted from 350  μ L of plasma using the NUCLISENS easyMAG system (bioMérieux). Total eluates were subjected to Turbo DNAse treatment (Thermo Fisher, Waltham, MA, United States) followed by library preparation using KAPA RNA HyperPrep kit (Roche). Libraries were pooled based upon DNA concentration and HCV quantity, assessed using the Quant-iT kit on the Glomax platform (Promega, Madison, WI, United States) and the Qiagen QuantiTect kit with primers and probes from Davalieva et al. [31]. Pools were enriched by hybridisation to a biotinylated probe set (Integrated DNA Technologies, described by Bonsall et al. [32]) followed by further PCR cycles depending upon HCV quantity. The two pools were pooled, again by concentration and HCV quantity. The final pool was quantified using the KAPA SYBR FASTA qPCR kit (Roche) on a PRISM 7500 (Applied BioSystems, Foster City, CA, United States) before being sequenced on a MiSeq using Reagent kit v2 (Illumina).
The Illumina read data were processed into SAM files using different bioinformatics pipelines at the different institutions. At Glasgow, reads were trimmed and filtered using TrimGalore [33] with quality threshold 30 and minimum read length 75. The most appropriate HCV reference sequence was identified via a k-mer-based approach, using k-mers unique to each genotype [34]. SAM files were generated by mapping against the best-matching HCV reference using Tanoti [8]. At Oxford, de-multiplexed sequence read-pairs were trimmed of low-quality bases using QUASR v7.01 [35] and adapter sequences with CutAdapt version 1.7.1 [36] and subsequently discarded if either read had fewer than 50 bases in its remaining sequence or if both reads matched the human reference sequence using Bowtie version 2.2.4 [4]. Remaining reads were mapped using BWA mem [5] and Stampy [7] against a database of reference sequences, both to choose an appropriate reference and to select those reads which formed a majority population for de novo assembly using VICUNA [10] and finishing with V-FAT [37]. The reads were then mapped back to this assembly using MOSAIK [6]. At PHE, human reads were filtered out from trimmed FASTQ files using SMALT [38], remaining reads were then assembled using VICUNA de novo assembly [10]. Contigs were matched to HCV reference genomes using BLAST [39] and gaps filled using LASTZ [40] to generate a draft assembly. Reads were then mapped to the draft assembly with BWA [5].
The deep sequencing data used in this study has been deposited in the NCBI Sequence Read Archive (http://www.ncbi.nlm.nih.gov/sra), under BioProject accession number PRJNA527067 and experiment accession numbers SRX5528430 to SRX5528670.

3.2. GLUE samReporter Design

The GLUE samReporter aims to provide a convenient tool for interpreting viral deep sequencing data. As part of the wider GLUE system [22], it can be used interactively in the command line interpreter or within bioinformatics scripts. Instantiated within a GLUE project for a specific category of viruses such as HCV-GLUE, it can take advantage of certain data objects within that project.
When interpreting viral deep sequencing data, one obstacle is mapping the SAM file coordinate space to a standard codon numbering system. Within the HCV-GLUE project the H77 strain (RefSeq accession NC_004102) is defined as the “master” reference sequence object. The precursor polyprotein and the 10 mature proteins are defined as coding features and their locations are specified on the H77 sequence. A wider set of reference sequence objects is also defined within HCV-GLUE; there are currently over 200 of these, based on the ICTV HCV resource [41]. HCV-GLUE then specifies an unconstrained “master” alignment object containing all these reference sequences, which is used to map their locations to those on the H77 sequence. HCV-GLUE also contains a reference phylogeny of the same set of sequences, computed using RAxML [42].
SAM files for HCV typically map each read to a single coordinate space. To interpret individual reads the samReporter must infer sequence homology (i.e., pairwise alignment) between this SAM file coordinate space and one of the reference sequences defined within GLUE—the “target” reference. The simplest method, to specify that the SAM file coordinate space is identical to that of a specific target reference sequence, is appropriate if one of the project’s reference sequences was used for the SAM file coordinate space. A more flexible “auto-align" method allows GLUE to generate a codon-aware pairwise alignment between the consensus of the SAM file and a selected target reference, using techniques based on BLAST+ [39]. This is appropriate if the SAM virus strain is closely related to the target reference, but importantly, it allows the method producing the SAM file, which may have a de novo element, to construct a coordinate space appropriate for the viral reads. The final and most general and robust method is “max-likelihood-placer”. This allows GLUE to select the target reference itself, by feeding the consensus of the SAM file into the first two stages of the GLUE genotyping pipeline. This consists of incorporating it into the master alignment using MAFFT [43], placing it in the reference phylogeny using RAxML-EPA [42] and selecting as the target the reference sequence with the lowest patristic distance from the SAM consensus. The auto-align method is then used to generate the homology. The master alignment will also typically act as the “linking” alignment, providing a mapping between the target reference and the master reference. The result of this process is then a chain of pairwise homology relationships, as shown in Figure 1, from each individual read to the SAM file coordinate space, to the target reference sequence and finally, via the linking alignment, to the master reference sequence.
The samReporter offers a range of GLUE commands for interpreting SAM files (Table 2). These each accept similar arguments for specifying the coordinate homology and genome region. The “variation scan” command scans each read for the presence or absence of sequence patterns defined by GLUE Variation objects [22]. If paired-end read data are supplied, the reads in each pair are processed together. Variation objects can encapsulate insertions, deletions, regular expressions and combinations at the nucleotide or amino acid level. In HCV drug resistance this capability may become important. For example, the Magellan-1 trial of the drug pibrentasvir found that the combination of a Methionine at NS5A position 28 with the deletion of the residue at NS5A position 32 was associated with resistance to the drug for HCV subtype 1b [44]. It remains to be seen whether such deletions and combinations occurring as minority variants are clinically relevant but if so, the samReporter offers a means of detecting these.
The commands also allow simple, optional filtering based on Phred base qualities, MAPQ mapping quality and depth. In command outputs, codon numbering is based on the system proposed by Kuiken et al. [18]; nucleotide coordinates both within the SAM file and the mapped location on the master reference are also given. Individual input files may be processed more quickly using parallelisation of command operations across multiple processors. Finally, for paired-end read data, regions where paired reads overlap are not counted twice in command outputs. As part of the GLUE engine, the SAM reporter is implemented in Java, using the Htsjdk library [45] to interpret the SAM format.
The samReporter is delivered as part of the GLUE software package. This study used GLUE version 1.1.33, HCV-GLUE project version 0.1.51 with PHE-HCV-DRUG-RESISTANCE extension version 0.1.21. GLUE is licensed under the open source GNU Affero General Public License version 3.0. and may be installed on Mac OSX, Windows or Linux systems. Documentation specific to the samReporter may be found at: http://tools.glue.cvr.ac.uk/#/deepSequencingData. Documentation for other aspects of GLUE and links to the source code repository can be found on other pages within the same web site.

4. Discussion

The results show that, within virus genomes of HCV retreatment patients, linkage between nucleotide variants within a codon location is not a purely theoretical issue. In a small number of cases among UK retreatment patients, such linkage did occur at sites critical for drug resistance. Approaches that do not preserve linkage, such as those encoding variants as ambiguity codes, cannot correctly resolve these cases. How would such a system deal with amino acid residues in the possible set but not in the definite set? If the system is configured not to report such residues, the result is false negative detection of a substitution at NS5A position 30 in three patients, obscuring A30K RAS in two cases. Conversely, if the system reports these residues, the result is false positive detection of the NS5B RAS S282T in three other patients. As far as we are aware, the current study is novel in terms of quantifying the effect of such linkage on resistance detection in real HCV patient data.
The current HCV-GLUE database [27] documents many RASs that combine substitutions at locations within the span of a typical Illumina read. The samReporter can report the presence or absence of these on any read (or read pair for paired-end data) that covers the relevant locations. Future work might consider whether detection of these “combination” RASs at a minority level are of clinical relevance. It would also be of interest to incorporate existing low frequency variant-calling mechanisms from the literature into GLUE. The samReporter and GLUE generally are intended to be useful in both research and clinical contexts. However, even once a SAM file has been generated from a sample, the samReporter only represents one part of the process in terms of drug resistance analysis. The HCV-GLUE system is currently being developed to provide a comprehensive drug resistance report, using samReporter to interpret a SAM file.
Other software, for example the VirVarSeq system [19], calls variants at the codon level but is focused on very low frequency variants. DiversiTools [46] provides frequencies of amino acids on a per read basis but does not link to a standardised coordinate system as is available in the GLUE framework. The geno2pheno[ngs-freq] system [20] directly interprets drug resistance in deep sequencing data. Users must transform their data into a table of nucleotide or codon frequencies and a web-based system then performs interpretation on this table, using a user-defined frequency threshold. In comparison with samReporter, this design facilitates fast transfer over a network since the frequency table is much more compact than a typical SAM or BAM file. However, some information is necessarily lost in the processing, for example the codon frequency table cannot encode linkage beyond a codon location which would be required for example to detect combination RASs.
While the current study applied samReporter to HCV, it can also be used to analyse deep sequencing data for other viruses. In many simple cases, the prerequisites would simply be a nucleotide alignment of alternative target reference sequences and a master reference sequence with coding region annotations. In more complex cases, for example where virus genomes contain ambisense genomes or RNA editing, GLUE and samReporter would need to take account of this. The GLUE samReporter shows that a simple, pragmatic software design can conveniently answer some common questions concerning within-host variation in viral deep sequencing data.

Supplementary Materials

The following are available online at https://www.mdpi.com/1999-4915/11/4/323/s1. The complete set of “ambiguous” codon locations that were found is supplied in a tab-delimited supplementary data file unclearCodonLocations.txt. Resistance associated locations are supplied in a tab-delimited supplementary data file resistanceAssociatedLocations.txt.

Author Contributions

Conceptualisation, J.B.S., E.C.T., J.L.M., J.H., J.M., E.B., D.L.R. and R.J.G.; methodology, J.B.S., J.H., D.S., D.F.B. and M.A.A.; software, formal analysis, and validation, JBS; data curation, E.A.-C., E.C.T., D.B., D.S., D.F.B. and M.A.A.; resources, A.d.S.F., L.T., C.F.M., D.F.B., E.A.C. and M.A.A.; writing—original draft preparation, J.B.S.; writing—review and editing, J.H., E.C.T., J.L.M., R.J.G., E.B., D.L.R. and J.M.; and supervision, R.J.G., D.L.R., E.C.T., J.M., E.B. and J.L.M.

Funding

This work was funded by the Medical Research Council (MRC) of the United Kingdom, award number MC_UU_12014/12. JBS was also part funded by a MRC Confidence in Concept award to the University of Glasgow, MC_PC_16045. ECT was funded by the Wellcome Trust (102789/Z/13/Z). EB is funded by the MRC, the Oxford National Institute for Health Research (NIHR) Biomedical Research Centre and is an NIHR Senior Investigator. The views expressed in this article are those of the authors and not necessarily those of the National Health Service (NHS), the NIHR, or the Department of Health.

Acknowledgments

The authors would like to thank the participants and clinicians at NHS sites who contributed samples, and Will Irving and Emma Hudson for their contributions, particularly for sample collection and project management.

Conflicts of Interest

The authors declare no conflict of interest.

Abbreviations

The following abbreviations are used in this manuscript:
BAMBinary alignment mapping
DAADirect-acting Antiviral
DNADeoxyribonucleic Acid
ICTVInternational Committee for the Taxonomy of Viruses
HCVHepatitis C virus
RASResistance-associated Substitution
RNARibonucleic Acid
SAMSequence alignment mapping
SNVSingle nucleotide variant
SVRSustained virological response

References

  1. Holmes, E.C. The Evolution and Emergence of RNA Viruses; Oxford University Press: Oxford, UK, 2009. [Google Scholar]
  2. Goodwin, S.; McPherson, J.D.; McCombie, W.R. Coming of age: Ten years of next-generation sequencing technologies. Nat. Rev. Genet. 2016, 17, 333–351. [Google Scholar] [CrossRef] [PubMed]
  3. Houldcroft, C.J.; Beale, M.A.; Breuer, J. Clinical and biological insights from viral genome sequencing. Nat. Rev. Microbiol. 2017, 15, 183–192. [Google Scholar] [CrossRef] [PubMed]
  4. Langmead, B.; Salzberg, S.L. Fast gapped-read alignment with Bowtie 2. Nat. Methods 2012, 9, 357–359. [Google Scholar] [CrossRef]
  5. Li, H.; Durbin, R. Fast and accurate short read alignment with Burrows–Wheeler transform. Bioinformatics 2009, 25, 1754–1760. [Google Scholar] [CrossRef]
  6. Lee, W.P.; Stromberg, M.P.; Ward, A.; Stewart, C.; Garrison, E.P.; Marth, G.T. MOSAIK: A Hash-Based Algorithm for Accurate Next-Generation Sequencing Short-Read Mapping. PLoS ONE 2014, 9, e90581. [Google Scholar] [CrossRef]
  7. Lunter, G.; Goodson, M. Stampy: A statistical algorithm for sensitive and fast mapping of Illumina sequence reads. Genome Res. 2011, 21, 936–939. [Google Scholar] [CrossRef]
  8. Tanoti: A BLAST-Guided Reference-Based Short Read Aligner. Available online: http://www.bioinformatics.cvr.ac.uk/tanoti.php (accessed on 24 February 2019).
  9. Bankevich, A.; Nurk, S.; Antipov, D.; Gurevich, A.A.; Dvorkin, M.; Kulikov, A.S.; Lesin, V.M.; Nikolenko, S.I.; Pham, S.; Prjibelski, A.D.; et al. SPAdes: A New Genome Assembly Algorithm and Its Applications to Single-Cell Sequencing. J. Comput. Biol. 2012, 19, 455–477. [Google Scholar] [CrossRef]
  10. Yang, X.; Charlebois, P.; Gnerre, S.; Coole, M.G.; Lennon, N.J.; Levin, J.Z.; Qu, J.; Ryan, E.M.; Zody, M.C.; Henn, M.R. De novo assembly of highly diverse viral populations. BMC Genom. 2012, 13, 475. [Google Scholar] [CrossRef]
  11. Wymant, C.; Fraser, C.; Hall, M.; Golubchik, T.; Bannert, N.; Fellay, J.; Fransen, K.; Porter, K.; Gourlay, A.; Grabowski, M.K.; et al. Easy and accurate reconstruction of whole HIV genomes from short-read sequence data with shiver. Virus Evol. 2018, 4, vey007. [Google Scholar] [CrossRef]
  12. Li, H.; Wysoker, A.; Handsaker, B.; Marth, G.; Abecasis, G.; Ruan, J.; Homer, N.; Durbin, R.; Fennell, T. The 1000 Genome Project Data Processing Subgroup. The Sequence Alignment/Map format and SAMtools. Bioinformatics 2009, 25, 2078–2079. [Google Scholar] [CrossRef] [PubMed]
  13. Wilm, A.; Aw, P.P.K.; Bertrand, D.; Yeo, G.H.T.; Ong, S.H.; Wong, C.H.; Khor, C.C.; Petric, R.; Hibberd, M.L.; Nagarajan, N. LoFreq: A sequence-quality aware, ultra-sensitive variant caller for uncovering cell-population heterogeneity from high-throughput sequencing datasets. Nucleic Acids Res. 2012, 40, 11189–11201. [Google Scholar] [CrossRef]
  14. Macalalad, A.R.; Zody, M.C.; Charlebois, P.; Lennon, N.J.; Newman, R.M.; Malboeuf, C.M.; Ryan, E.M.; Boutwell, C.L.; Power, K.A.; Brackney, D.E.; et al. Highly Sensitive and Specific Detection of Rare Variants in Mixed Viral Populations from Massively Parallel Sequence Data. PLoS Comput. Biol. 2012, 8, e1002417. [Google Scholar] [CrossRef] [PubMed]
  15. Yang, X.; Patrick, C.; Macalalad, A.; Henn, M.R.; Zody, M.C. V-Phaser 2: Variant inference for viral populations. BMC Genom. 2013, 14, 674. [Google Scholar] [CrossRef]
  16. Sandmann, S.; de Graaf, A.O.; Karimi, M.; van der Reijden, B.A.; Hellström-Lindberg, E.; Jansen, J.H.; Dugas, M. Evaluating Variant Calling Tools for Non-Matched Next-Generation Sequencing Data. Sci. Rep. 2017, 7, 43169. [Google Scholar] [CrossRef]
  17. Ibrahim, B.; McMahon, D.P.; Hufsky, F.; Beer, M.; Deng, L.; Mercier, P.L.; Palmarini, M.; Thiel, V.; Marz, M. A new era of virus bioinformatics. Virus Res. 2018, 251, 86–90. [Google Scholar] [CrossRef] [PubMed]
  18. Kuiken, C.; Combet, C.; Bukh, J.; Shin-I, T.; Deleage, G.; Mizokami, M.; Richardson, R.; Sablon, E.; Yusim, K.; Pawlotsky, J.M.; et al. A comprehensive system for consistent numbering of HCV sequences, proteins and epitopes. Hepatology 2006, 44, 1355–1361. [Google Scholar] [CrossRef]
  19. Verbist, B.M.; Aerssens, J.; Reumers, J.; Thys, K.; Van der Borght, K.; Clement, L.; Thas, O.; Talloen, W.; Wetzels, Y. VirVarSeq: A low-frequency virus variant detection pipeline for Illumina sequencing using adaptive base-calling accuracy filtering. Bioinformatics 2014, 31, 94–101. [Google Scholar] [CrossRef] [PubMed]
  20. Döring, M.; Büch, J.; Friedrich, G.; Pironti, A.; Kalaghatgi, P.; Knops, E.; Heger, E.; Obermeier, M.; Däumer, M.; Thielen, A.; et al. geno2pheno[ngs-freq]: a genotypic interpretation system for identifying viral drug resistance using next-generation sequencing data. Nucleic Acids Res. 2018, 46, W271–W277. [Google Scholar] [CrossRef] [PubMed]
  21. Schirmer, M.; Sloan, W.T.; Quince, C. Benchmarking of viral haplotype reconstruction programmes: An overview of the capacities and limitations of currently available programmes. Brief. Bioinform. 2012, 15, 431–442. [Google Scholar] [CrossRef]
  22. Singer, J.B.; Thomson, E.C.; McLauchlan, J.; Hughes, J.; Gifford, R.J. GLUE: A flexible software system for virus sequence data. BMC Bioinform. 2018, 19, 532. [Google Scholar] [CrossRef] [PubMed]
  23. Vermehren, J.; Park, J.S.; Jacobson, I.M.; Zeuzem, S. Challenges and perspectives of direct antivirals for the treatment of hepatitis C virus infection. J. Hepatol. 2018, 69, 1178–1187. [Google Scholar] [CrossRef] [PubMed]
  24. Sorbo, M.C.; Cento, V.; Maio, V.C.D.; Howe, A.Y.; Garcia, F.; Perno, C.F.; Ceccherini-Silberstein, F. Hepatitis C virus drug resistance associated substitutions and their clinical relevance: Update 2018. Drug Resist. Updates 2018, 37, 17–39. [Google Scholar] [CrossRef] [PubMed]
  25. European Association for the Study of the Liver. Recommendations on Treatment of Hepatitis C 2016. J. Hepatol. 2017, 66, 153–194. [Google Scholar] [CrossRef] [PubMed]
  26. IUPAC-IUB Commission on Biochemical Nomenclature (CBN). Abbreviations and symbols for nucleic acids, polynucleotides and their constituents. Recommendations 1970. Biochem. J. 1970, 120, 449–454. [Google Scholar] [CrossRef]
  27. HCV-GLUE: A Sequence Data Resource for Hepatitis C Virus. Available online: http://hcv.glue.cvr.ac.uk (accessed on 24 February 2019).
  28. Kalaghatgi, P.; Sikorski, A.M.; Knops, E.; Rupp, D.; Sierra, S.; Heger, E.; Neumann-Fraune, M.; Beggel, B.; Walker, A.; Timm, J.; et al. Geno2pheno[HCV]—A Web-based Interpretation System to Support Hepatitis C Treatment Decisions in the Era of Direct-Acting Antiviral Agents. PLoS ONE 2016, 11, e0155869. [Google Scholar] [CrossRef]
  29. Batty, E.M.; Wong, T.H.N.; Trebes, A.; Argoud, K.; Attar, M.; Buck, D.; Ip, C.L.C.; Golubchik, T.; Cule, M.; Bowden, R.; et al. A Modified RNA-Seq Approach for Whole Genome Sequencing of RNA Viruses from Faecal and Blood Samples. PLoS ONE 2013, 8, e66129. [Google Scholar] [CrossRef] [PubMed]
  30. Lamble, S.; Batty, E.; Attar, M.; Buck, D.; Bowden, R.; Lunter, G.; Crook, D.; El-Fahmawi, B.; Piazza, P. Improved workflows for high throughput library preparation using the transposome-based Nextera system. BMC Biotechnol. 2013, 13, 104. [Google Scholar] [CrossRef] [PubMed]
  31. Davalieva, K.; Kiprijanovska, S.; Plaseska-Karanfilska, D. Fast, reliable and low cost user-developed protocol for detection, quantification and genotyping of hepatitis C virus. J. Virol. Methods 2014, 196, 104–112. [Google Scholar] [CrossRef]
  32. Bonsall, D.; Ansari, M.; Ip, C.; Trebes, A.; Brown, A.; Klenerman, P.; Buck, D.; STOP-HCV Consortium; Piazza, P.; Barnes, E.; Bowden, R. ve-SEQ: Robust, unbiased enrichment for streamlined detection and whole-genome sequencing of HCV and other highly diverse pathogens [version 1; referees: 2 approved, 1 approved with reservations]. F1000Research 2015, 4, 1062. [Google Scholar] [CrossRef] [PubMed]
  33. TrimGalore: A Wrapper around Cutadapt and FastQC to Consistently Apply Adapter and Quality Trimming to FastQ Files, with Extra Functionality for RRBS Data. Available online: https://github.com/FelixKrueger/TrimGalore (accessed on 24 February 2019).
  34. Sreenu, V.B.; (MRC-University of Glasgow Centre for Virus Research, Glasgow, UK). Personal Communication, 2019.
  35. Gaidatzis, D.; Lerch, A.; Hahne, F.; Stadler, M.B. QuasR: Quantification and annotation of short reads in R. Bioinformatics 2014, 31, 1130–1132. [Google Scholar] [CrossRef]
  36. Martin, M. Cutadapt removes adapter sequences from high-throughput sequencing reads. EMBnet J. 2011, 17, 10–12. [Google Scholar] [CrossRef]
  37. V-FAT: A Post-Assembly Pipeline for the Finishing and Annotation of Viral Genomes. Available online: https://www.broadinstitute.org/viral-genomics/v-fat (accessed on 24 February 2019).
  38. SMALT: A Mapper for DNA Sequencing Reads. Available online: https://www.sanger.ac.uk/science/tools/smalt-0 (accessed on 24 February 2019).
  39. Camacho, C.; Coulouris, G.; Avagyan, V.; Ma, N.; Papadopoulos, J.; Bealer, K.; Madden, T.L. BLAST+: Architecture and applications. BMC Bioinform. 2009, 10, 421. [Google Scholar] [CrossRef] [PubMed]
  40. Harris, R.S. Improved Pairwise Alignment of Genomic DNA. Ph.D. Thesis, Pennsylvania State University, State College, PA, USA, 2007. [Google Scholar]
  41. Smith, D.B.; Bukh, J.; Kuiken, C.; Muerhoff, A.S.; Rice, C.M.; Stapleton, J.T.; Simmonds, P. Expanded classification of hepatitis C virus into 7 genotypes and 67 subtypes: Updated criteria and genotype assignment web resource. Hepatology 2014, 59, 318–327. [Google Scholar] [CrossRef]
  42. Stamatakis, A. RAxML version 8: A tool for phylogenetic analysis and post-analysis of large phylogenies. Bioinformatics 2014, 30, 1312–1313. [Google Scholar] [CrossRef] [PubMed]
  43. Katoh, K.; Standley, D.M. MAFFT Multiple Sequence Alignment Software Version 7: Improvements in Performance and Usability. Mol. Biol. Evol. 2013, 30, 772–780. [Google Scholar] [CrossRef] [PubMed]
  44. Poordad, F.; Pol, S.; Asatryan, A.; Buti, M.; Shaw, D.; Hézode, C.; Felizarta, F.; Reindollar, R.W.; Gordon, S.C.; Pianko, S.; et al. Glecaprevir/Pibrentasvir in patients with hepatitis C virus genotype 1 or 4 and past direct-acting antiviral treatment failure. Hepatology 2018, 67, 1253–1260. [Google Scholar] [CrossRef] [PubMed]
  45. A Java API for High-Throughput Sequencing Data (HTS) Formats. Available online: http://samtools.github.io/htsjdk/ (accessed on 24 February 2019).
  46. DiversiTools: Tool for Analysing Viral Diversity from HTS. Available online: http://josephhughes.github.io/DiversiTools/ (accessed on 24 February 2019).
Figure 1. The chain of pairwise homology relationships between reads and the master reference sequence (H77 for HCV), established during the operation of GLUE samReporter.
Figure 1. The chain of pairwise homology relationships between reads and the master reference sequence (H77 for HCV), established during the operation of GLUE samReporter.
Viruses 11 00323 g001
Table 1. Ambiguous resistance-associated locations resolved using GLUE samReporter.
Table 1. Ambiguous resistance-associated locations resolved using GLUE samReporter.
SequencingSampleSubtypeVirusCodonAmbiguousTypicalPossibleConfirmed
FacilityIDProteinLocationTripletResidue (s)Residues SetResidues Set
GlasgowHCV2943bNS5B282WSYSCSTS
GlasgowHCV3003aNS5A30RMGAAEKTAK
PHER1271aNS5A24RSGKAGRTGT
PHER1643aNS5A30RMGAAEKTAK
PHER254rNS5B159YTMLFLL
PHER254rNS5B282WSCSCSTS
PHER364rNS5B282WSCSCSTS
PHER671aNS5A30YAWQHQYQY
PHER911aNS5A28RYGMAMTVMV
Oxford74443aNS5A62SYASTALPVAL
Table 2. GLUE samReporter commands.
Table 2. GLUE samReporter commands.
CommandDescription
nucleotideGenerate a table of nucleotide frequencies within a specific genome region.
depthGenerate a table of read depths within a specific genome region.
nucleotide-consensusGenerate a FASTA consensus file, optionally using ambiguity codes.
amino-acidGenerate a table of amino acid residue frequencies within a specific protein-coding region.
codon-tripletsGenerate a table of codon frequencies within a specific protein-coding region.
variation scanScan for the presence or absence of GLUE Variations within reads.
export nucleotide-alignmentExport a specific part of the SAM alignment as a FASTA file.

Share and Cite

MDPI and ACS Style

Singer, J.B.; Thomson, E.C.; Hughes, J.; Aranday-Cortes, E.; McLauchlan, J.; da Silva Filipe, A.; Tong, L.; Manso, C.F.; Gifford, R.J.; Robertson, D.L.; et al. Interpreting Viral Deep Sequencing Data with GLUE. Viruses 2019, 11, 323. https://doi.org/10.3390/v11040323

AMA Style

Singer JB, Thomson EC, Hughes J, Aranday-Cortes E, McLauchlan J, da Silva Filipe A, Tong L, Manso CF, Gifford RJ, Robertson DL, et al. Interpreting Viral Deep Sequencing Data with GLUE. Viruses. 2019; 11(4):323. https://doi.org/10.3390/v11040323

Chicago/Turabian Style

Singer, Joshua B., Emma C. Thomson, Joseph Hughes, Elihu Aranday-Cortes, John McLauchlan, Ana da Silva Filipe, Lily Tong, Carmen F. Manso, Robert J. Gifford, David L. Robertson, and et al. 2019. "Interpreting Viral Deep Sequencing Data with GLUE" Viruses 11, no. 4: 323. https://doi.org/10.3390/v11040323

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop