key: cord-0852849-47kmwl6s authors: Lin, Hsin-Hung; Liao, Yu-Chieh title: drVM: a new tool for efficient genome assembly of known eukaryotic viruses from metagenomes date: 2017-01-20 journal: Gigascience DOI: 10.1093/gigascience/gix003 sha: de64592c6c3786b48b73cac2debc515c642e31f0 doc_id: 852849 cord_uid: 47kmwl6s Background: Virus discovery using high-throughput next-generation sequencing has become more commonplace. However, although analysis of deep next-generation sequencing data allows us to identity potential pathogens, the entire analytical procedure requires competency in the bioinformatics domain, which includes implementing proper software packages and preparing prerequisite databases. Simple and user-friendly bioinformatics pipelines are urgently required to obtain complete viral genome sequences from metagenomic data. Results: This manuscript presents a pipeline, drVM (detect and reconstruct known viral genomes from metagenomes), for rapid viral read identification, genus-level read partition, read normalization, de novo assembly, sequence annotation, and coverage profiling. The first two procedures and sequence annotation rely on known viral genomes as a reference database. drVM was validated via the analysis of over 300 sequencing runs generated by Illumina and Ion Torrent platforms to provide complete viral genome assemblies for a variety of virus types including DNA viruses, RNA viruses, and retroviruses. drVM is available for free download at: https://sourceforge.net/projects/sb2nhri/files/drVM/ and is also assembled as a Docker container, an Amazon machine image, and a virtual machine to facilitate seamless deployment. Conclusions: drVM was compared with other viral detection tools to demonstrate its merits in terms of viral genome completeness and reduced computation time. This substantiates the platform's potential to produce prompt and accurate viral genome sequences from clinical samples. Viruses are the most abundant biological entities on Earth and are found among all cellular forms of life including animals, plants, bacteria, and fungi. More than 4500 viral species have been discovered; their sequence information has been collected by researchers [1] [2] [3] . Viruses have caused some of the most dramatic and deadly disease pandemics in human history and viral disease outbreaks tend to occur every several years. Over the past two decades, avian influenza H5N1 virus [4] , SARS coronavirus, H1N1 pandemic, MERS coronavirus [5] , Ebola virus [6] , and Zika virus [7] have emerged in the human population. During such outbreaks, identification of the causative agent and comparative genome analysis is of cornerstone importance for disease surveillance and epidemiology. Unbiased next-generation sequencing (NGS) is emerging as an attractive approach for viral identification from varied samples, including blood, feces, sputum, and other swab samples [8, 9] . The technique holds the promise to aid in the identification of potential pathogens in a single assay without a prior knowledge of the 1 target [10] . However, computational analyses for crude metagenomic deep-sequencing reads are extremely time-consuming. SURPI [10] and Taxonomer [11] are pathogen detection tools that have been proposed to rapidly analyze metagenomic NGS data for comprehensive diagnostic applications. However, both tools are incapable of complete viral genome assembly. VIP pursues the same strategy as SURPI, subtraction to identification, to subtract host and bacteria reads prior to the identification of viral reads, although it does provide an alternative strategy to the assembly of reads under a genus, classification to assembly, hence enabling improved viral genome assembly [12] . Although VIP generates phylogenetic trees, thereby facilitating the visualization of genealogy between a candidate virus and existing reference sequences, it does not produce assembled viral sequences in its final report. Moreover, ease-of-use challenges associated with operating SURPI and VIP impede their applications in most laboratories and are often accessible only by trained personnel. VirusTAP is a web-based integrated NGS analysis tool for viral genome assembly from metagenomic reads [13] . This userfriendly tool enables users to obtain viral genomes more easily by merely uploading raw NGS reads and clicking on several selections. However, VirusTAP only accepts Illumina data and does not support users to update reference databases. Therefore, tools for viral metagenomics analyses are urgently required that are substantially more computationally efficient, accurate (for compete viral genome assembly), and easy to use. Here we present drVM (detect and reconstruct known viral genomes from metagenomes), a bioinformatics pipeline that first provides rapid classification of NGS reads generated by Illumina or Ion Torrent sequencing technology against a viral database, then partitions the viral reads into genus groups, and finally de novo assembles viral genomes from the corresponding genus-level reads. For ease of deployment, a Docker container [14] , an Amazon machine image, and a virtual machine [15] image were created for drVM. The performance of the platform was evaluated in the analysis of 349 sequence data in the Sequence Read Archive (SRA) from 18 independent studies [8-10, 13, 16-29] . These data sets encompass a variety of sample types, viruses, and sequencing depths. drVM was demonstrated to be highly adept at the detection and reconstruction of various known viral genomes and concomitantly outperforms other analytical pipelines including SURPI, VIP, and VirusTAP. Viral nucleotide sequences were obtained from the Nucleotide database of the National Center for Biotechnology Information (NCBI) using the query term "(complete[title]) AND (viridae[organism])"; this query resulted in 642 079 hits (as of 16 March 2016) and increased to 705 577 hits (as of 20 October 2016). Based on each sequence identifier (accession number) of the viral sequence, its taxonomic ID, scientific name, and genus-level annotation were separately obtained from the NCBI Taxonomy database. Viral sequences with taxonomy ID not included in the virus division (division id = 9), those with taxonomic information absent, and those lacking genus-level annotation were labeled "nonViral, "noTax," and "noGenus," respectively. The noGenus sequences can be used by adding "-kn on" option in the creation of databases. With the exception of no-Genus sequences, those sequences with the nonViral or noTax labels were excluded from database construction. The remaining viral sequences were utilized as rawDB. Three hundred and seventy-seven viral genomes were obtained by filtering with host "human" from the NCBI viral genome resource to retrieve 684 sequences (1 March 2016) [1] . The viral sequences were segmented into their corresponding genus level for refDB; the corresponding refDB was uploaded to SourceForge for later use (https://sourceforge.net/projects/sb2nhri/files/drVM/refDB. tar.gz). To increase read alignments and reduce memory requirements, rawDB was split into eight sub-databases, and each contained sequences with total length <200 Mbp. SNAP (version 0.15.4) [30] , possessing a default seed size of 20, was used to generate index tables (snap index virus) for the viral sub-databases. In addition, a BLAST database (blast index virus) was created by makeblastdb (BLAST 2.2.28+) [31] from rawDB to enable contig annotation. The drVM pipeline is implemented in Python and incorporates several open-source tools, including BLAST, SNAP, and SPAdes [32] . The package comprises two modules: CreateDB.py and drVM.py. A schematic flowchart of drVM is shown in Fig. 1 . In CreateDB.py, viral sequences (provided by the user) are processed to produce rawDB for SNAP and BLAST database construction, and refDB is downloaded from the SourceForge link. drVM.py takes single-or paired-end reads as input. It aligns reads to SNAP DB and, accordingly, identifies viral reads using the following parameters: snap single -x -h 250 -d 24 -n 25 -F a. Based on taxonomic information (genus-level annotation) of the aligned sequence, the viral reads are partitioned into genuslevel groups. Each group is labeled according to its corresponding genus. By examining the aligned sequences with reads, sequence coverage and read depth are calculated. Maximum coverage and average depth for a genus are estimated by taking all aligned sequences corresponding to that genus into consideration. Viral reads in a genus with average depth more than or equal to min depth (default = 1) undergo de novo assembly via SPAdes (v.3.6.1). Prior to assembly, digital normalization [33] in khmer [34] is employed to remove reads with high-abundance (default = 100) k-mers. Using BLAST, each genus-level assembly is annotated to its closest reference against refDB using blastn (identity 80%). Each reference is examined to confirm that it contains at least a 50% alignment rate. If this procedure returns no hits, the assembly is annotated by BLAST against rawDB. Note that, although the viral sequences in refDB are restricted to human viruses, there is no filter by host option in rawDB. Reads are aligned to contigs by means of SOAP2 [35] and the read-covered contigs are placed into a coverage plot with reference-guide coordinates. To increase contig continuity, reads aligned to contigs corresponding to a reference are extracted for pairs and those paired reads are re-assembled. This re-assembly process is only performed for paired-end reads. A reference genome of the hepatitis C virus (HCV; NC 004102.1) was used to simulate metagenomes with 10×, 15×, 20×, 30×, 40×, and 50× viral reads using VirtualNextGenSequencer [36] . The simulated reads were concatenated to 1-Gbp sequencing reads (3.5 million paired-end 150-bp reads) of liver cancer cells (SRR3031107 in SRA) and 328-Mbp reads of a human microbiome sample (SRR062412, 100-bp paired-end reads containing any Ns were removed). The reads of liver cancer cells and the reads from the human microbiome project (HMP) were taken as host and bacterial metagenomes. Three reference genomes of respiratory viruses including human enterovirus (NC 001612 for CA16), human rhinovirus (NC 001617 for HRV), and human respiratory syncytial virus (NC 001781 for HRSV) were used separately to simulate 20×, 20× and 40×, and 20× and 80× viral sequences using VirtualNextGenSequencer. The simulated reads (all 20×, and 20×-40×-80×) and randomly selected reads (1 Gbp, 5 million paired-end 100-bp reads), as a background, from an influenzanegative sample (ERR690488) [9] were used to assess the ability of drVM to assemble viral genomes within the same genus (human enterovirus and rhinovirus). A total of 349 sequencing runs in the SRA were downloaded (see Table S1 ). The metagenome datasets based on prior studies [8-10, 13, 16-29] are summarized in Table 1 . Each run was analyzed by drVM: drVM.py -1 read1.fastq -2 read2.fastq -t 16 (-type iontorrent for Ion Torrent datasets) on a server (Intel Xeon E7-4820, 2.00GHz with 256 GB of RAM). drVM was designed to detect and reconstruct known viral genomes from metagenomes. As described in the Materials and Methods, it contains two modules: CreateDB.py and drVM.py (Fig. 1) . The viral sequences downloaded from NCBI were processed by CreateDB.py to produce SNAP and BLAST databases. Taxonomy information was also automatically extracted from NCBI. In drVM.py, metagenomic reads that were aligned to complete viral sequences were firstly partitioned into genus-level groups to facilitate de novo assembly of classified reads. Each genus-level assembly was then annotated with a close reference in refDB or rawDB to produce corresponding coverage plots. The drVM pipeline was implemented, in Python, to incorpo-rate open-source tools including BLAST, khmer, SNAP, SOAP2, and SPAdes. The software is open-source and available for download: https://sourceforge.net/projects/sb2nhri/files/drVM/. In addition to the drVM script, the module is distributed as a Docker image in the Docker Hub (https://hub.docker.com/ r/990210oliver/drvm/) repository, an Amazon Machine Image (AMI) in Community AMIs, and as a virtual machine image (drVM.ova) on the sourceforge website. The instructions for users can be found in Supplementary file 2. With the Docker, Amazon machine image, and the drVM virtual machine, users are able to interface with drVM with ease. In addition to executing commands in a terminal window ( Fig. 2A) , a graphical user interface ( Fig. 2B ) was created in the drVM virtual machine. Users are thus able to construct the required databases for drVM by simply clicking on the 'Create' button featured in Cre-ateDB.py. Following a 30-minute period during which DB is created, users are able to analyze metagenomic data with drVM.py to produce a folder (Fig. 2C ) containing assembled viral genomes ( * .ctg.fa) along with annotated coverage plots (Fig. 2D ). Note that viral sequences were fully assembled, de novo, by SPAdes using reads within the same genus, and each assembled contig (e.g. NODE 2 length 7654 and NODE 1 length 7914 in Fig. 2D ) was annotated with its closely related genome (e.g. Human papillomavirus type 45 and type 53). The coverage plots were generated by plotting read coverage across genomic position, with the y-axis representing read depth. To reconstruct the 9646-bp HCV genome from the simulated datasets (485-2425 100-bp paired-end HCV reads for 10× to 50× HCV + 3.5 million SRR3031107 liver cancer cell paired-end reads + 1.6 million SRR062412 HMP paired-end reads), drVM first corresponding genus fastq files (CA16 and HRV reads in Enterovirus and HRSV in Orthopneumovirus, shown in Fig. 3A and E) and successfully reconstructed the three viral genomes (Fig. 3B-D and F-H) in the two genus folders. The assembled sequences of length 7145 to 15 224 bp were 100% identical to their reference genomes. The simulations revealed that few bacterial and host reads (<0.02%, 274 of 1.6 million) were classified into the viral genus-level fastq files, and the existence of background reads did not interfere with viral assembly. Three hundred and forty-nine sequencing datasets from 18 research studies (Table 1 and Table S1 ) were downloaded and analyzed by means of drVM. The results generated by the drVM package (except filtered reads) for the 349 runs are provided at http://sb.nhri.org.tw/drVM/, and the assembled viral sequences (also in Table S1 ), along with their corresponding coverage plots, are available for download. As shown in Table S1 and the website, drVM produced coverage plots in analyzing metagenomics reads of 260 sequencing runs and reconstructed viral genomes from 147 runs by presenting a single contig mapped on a reference. Here, we take the second study listed in Table 1 as an example; the authors described sequence-independent amplification for samples containing ultra-low amounts of viral RNA coupled with 34-run Illumina sequencing (SRR513075 to SRR527726 and SRR629705-9 listed in Table S1 ). De novo assembly, optimized for viral genomes, was performed so as to capture 96% to 100% of the viral protein coding region of the human immunodeficiency virus (HIV), respiratory syncytial virus (RSV), and West Nile virus (WNV); 31 consensus genome assemblies have been submitted to NCBI (JX503071-JX503101) [19] . These viruses were successfully detected by drVM in separate samples through the creation of coverage plots for the 34 sequencing runs (see http://sb.nhri.org.tw/drVM/). drVM reconstructed complete viral genomes in 25 runs, thus the remaining 9 runs are labeled as "detection" in Table 1 . The assembled genome sequences such as HIV in SRR513075, WNV in SRR527701, and RSV in SRR527708 can be found in Table S1 . Although drVM did not reconstruct HIV genomes for JX503077 and JX503083 from SRR513078 and SRR527710, respectively, it produced HIV contigs with length >4000 bp. The drVM-produced viral sequences shared over 99.9% average sequence identity to the reference genomes (20 pairs of reference and assembled sequence). In addition to HIV, RSV, and WNV, drVM reconstructed GB virus C genomes in SRR513075, SRR513080, SRR513087, SRR629705, and SRR629708. The maximum identity of the assembled sequences to the reference genomes deposited in NCBI's Nucleotide collection (nr/nt) is 93%, which reveals that these assembled sequences have yet to be published. drVM also detected hepatitis C viruses in SRR513080 (three assembled HCV contigs > 1 kbp), SRR629705 (one HCV contig > 5 kbp), and SRR629708; torque teno virus (contigs > 1.5 kbp) was also detected in SRR527718, SRR527725, SRR629705, and SRR629707. This finding has, to date, not been reported in the literature. Furthermore, 12 complete or near-complete viral genomes of viruses including adenovirus, norovirus, and hepatitis B virus have been obtained and submitted to NCBI (KJ194499-KJ194510) in the fourth study [20] ; drVM automatically produced nine complete genomes among them, with over 99.9% average sequence identity to the reference genomes (Table S1 ). In analyzing reads of the 20 sequencing runs, drVM reconstructed 17 viral genomes in 11 runs and did not produce any coverage plot for the other 9 runs (Table 1 ). An additional eight viral genomes, belonging to plant viruses (including cucumber green mottle mosaic virus, paprika mild mottle virus, pepper mild mottle virus, tobacco mosaic virus, and tomato mosaic virus), were assembled by drVM. Genomes of the four plant viruses, with the exception of pepper mild mottle virus, have undergone complete assembly by the prior study [20] , albeit the plant viral sequences provided in Table S1 have not been published. As for the fourth study from the bottom of Table 1 , the RNA shotgun sequencing method has been used in 82 samples, but only 17 sequences of norovirus (HF952119-HF952135) have been submitted to NCBI [8] . drVM produced coverage plots for all 82 sequencing runs (shown on the website) and assembled two hepatitis C virus genomes, 74 norovirus genomes, two human picobirnavirus genomes, and one pepino mosaic virus genome from 76 sequencing runs (Table S1 ). Over 99.98% average sequence identity was obtained when the drVMproduced sequences were compared to the 17 corresponding references. To illustrate the wide-ranging versatility of drVM, it was also leveraged to detect/reconstruct viral genomes from respiratory samples [9] , the fifth study from the bottom of Table 1 . drVM produced 2 complete influenza A H1N1 virus genomes (ERR690494 and ERR690532 in http://sb.nhri.org.tw/drVM/) and 10 H3N2 virus genomes (e.g., ERR690510) in 12 influenza-positive samples and one human respiratory syncytial virus in a negative control sample (ERR690491). Taken together, various viral genomes including DNA, RNA, and retro-transcribing viruses ( Table 2) have been reconstructed by drVM; this has been applied (Table 2) among 349 metagenomic sequencing runs. Over 150 assembled viral genomes are provided in Table S1 . Unlike SURPI [10] , VIP [12] , and VirusTAP [13] , drVM directly identifies reads by aligning them to complete viral sequences and therefore is expected to save a substantial amount of computational time from subtracting reads of the host and colocated bacteria. Three datasets -SRR1170797, SRR1106548, and DRR049387 -used in VIP, SURPI, and VirusTAP were separately input into them for the pipeline evaluation [10, 12, 13] . Two sequencing runs comprising co-existing multiple human papillomavirus types [21] and segmented-genome influenza viruses [9] were used as additional datasets for performance comparison. As demonstrated in Table 3 , drVM requires the shortest execution time with regards to SRR1106548 and DRR049387 and the second-shortest time for the other three datasets. Nevertheless, it produced a complete genome of bovine viral diarrhea virus (genome size: 12.5 kbp) in SRR1170797, two complete genomes of human papillomavirus type 45 and type 53 (genome size: ∼7.8 kbp) in SRR062073, and eight complete segments of influenza A virus H3N2 in ERR690519. Commands and results can be found in Supplementary information. Note that the analyses of drVM, SURPI, and VIP (in Table 3 ) were performed on a quad-core CPU with 128 GB RAM while VirusTAP was executed on a 120-core CPU web server with 1 TB RAM. Therefore, drVM was validated to be the most rapid tool for virus identification when computational hardware was considered. Moreover, drVM reconstructed the complete viral genomes from metagenomics reads of SRR1170797, SRR062073, and ERR690519 runs, while the other three tools were not able to produce complete genomes for these viruses. The outputs generated by each tool running on the datasets delineated in Table 3 are available at: https://sourceforge. net/projects/sb2nhri/files/drVM/Comparison/. Please also note that the results are reproducible even when running a drVM virtual machine with a configured memory size of 8 GB on a Windows system with Intel Xeon E31248 CPU and 32 GB RAM (see Supplementary information). To simulate the disturbance of host reads, homo sapiens raw reads from liver cancer cells (SRR3031107) were concatenated to sequencing reads (SRR544883) from the hepatitis C virus infection [18] . Before read concatenation, drVM reconstructed a GB virus C genome (length of 9244 bp) from 101 364 paired-end reads in fastq files of Pegivirus in SRR544883, as shown in Table 2 . Although the software managed to reconstruct the viral genome of GB virus C from the concatenated reads, execution time increased by a factor of three (from 43 minutes to 2 hours 7 minutes while analyzing read bases of 711 Mb to 10 Gb). Please note that SRR3031107 reads were not classified into fastq files of Pegivirus when the concatenated reads (SRR3031107 + SRR544883) were employed as inputs to drVM. It was therefore confirmed that host read subtraction is not necessary in drVM. Taken together, drVM not only facilitates the rapid detection of viral reads but also enables the de novo assembly of the classified reads into viral genomes. As NGS technology is becoming a more common means to detect pathogens in clinical samples, our goal is to establish a simple and effective pipeline that allows accurate and rapid viral genome reconstruction from metagenomic NGS data generated from complex clinical samples. As described in SURPI, SNAP executes 10-100× more rapidly than existing alignment tools including Bowtie 2 [37] and BWA [38] . drVM and SURPI use SNAP while VIP and VirusTAP utilize Bowtie 2 and BWA-SW [39] , respectively. SNAP coupling with the light reference database (viral sequences vs. human, bacterial, and viral sequences used in SURPI, VIP, and VirusTAP) yields a noteworthy reduction in the processing time for viral read identification in drVM. Furthermore, the reference database can easily be updated whenever necessary (see Supplementary information). In contrast, SURPI classifies reads against viral and bacterial databases to identify all potential pathogens, which invariably requires extended execution time and requires more effort with regards to ensuring that the references are updated and current. In drVM, viral reads with the loosest edit distance of 24 (in SNAP) were partitioned into genus-level groups based on the virus taxonomy retrieved from the NCBI Taxonomy databases, excluding phages. The filtered reads belonging to a viral genus are therefore allowed to be divergent from reference genomes so long as there is one contiguous seed of 20 bases matching exactly to a reference. However, since drVM relies on known viral sequences for viral read identification and genus-level partition, it may not be able to discover novel viruses that are very different to known viruses. For subsequent de novo assembly, digital normalization was then employed to correct uneven read depth distribution so as to eliminate redundant reads while retaining sufficient information. For example, drVM produced a 7455-bp contig of porcine kobuvirus for ERR1097471 ( Table 2 , the assembled sequence in Table S1 ) but produced a fragmented assembly when digital normalization was not used (-dn off). This assembled sequence shared only 90% identity at nucleotide level with a closely related porcine kobuvirus genome sequence deposited in NCBI's Nucleotide collection (nr/nt), hence demonstrating that drVM is able to produce a complete genome sequence of porcine kobuvirus from the intestinal virome in neonatal piglets [27] . Additionally, normalization enables us to reduce the processing time required for assembly. For example, not activating the digital normalization routine in drVM increased the execution time of ERR1097472 from 20 minutes to 3 hours. It is important to note that the digital normalization routine is employed to downsample reads, insinuating that the results produced by drVM can vary (e.g., SRR527703 in http://sb.nhri.org.tw/drVM/) from run to run. The normalized reads were assembled, in a de novo fashion, by SPAdes with multiple k-mer sizes (21, 33, 55. . . automatically selected based on read length). Since SPAdes operates with Illumina and Ion Torrent reads, drVM is able to handle sequencing reads produced by these two platforms (default for Illumina,type iontorrent for Ion Torrent). Moreover, drVM annotates each genus-level assembly with a close reference to produce the corresponding coverage plots. If multiple contigs are present in one coverage plot, reads aligned to the contigs are extracted in pairs for subsequent re-assembly; such a process is able to improve genome completeness. An example can be seen in the run corresponding to SRR527705 -fragmented contigs were annotated with the WNV in the pre.run routine; drVM produced a 11 017-bp contig of the complete genome (see http://sb.nhri.org.tw/drVM/ for the details). Over 99.98% of the target sequence identity was obtained in the drVM-produced contig when referenced against the submitted assembly (JX503096.1) [19] , as shown in Table S1 . In the comparative study of VIP and VirusTAP, the authors have compared their assemblies with direct metagenomic assemblies via Ensemble Assembler, IDBA UD, A5-miseq, and CLC workbench. The results have led the authors to conclude that "classification to assembly" outperformed direct assembly in terms of assembly continuity and execution time [12, 13] , suggesting that to extract viral reads from metagenomes is a prior step to sequence assembly. Although drVM was not compared with SPAdes, it was compared against SURPI, VIP, and VirusTAP. As evident from Table 3 , drVM produced complete genomes of bovine viral diarrhea virus and human papillomavirus in the analysis of reads produced by Ion Torrent and Illumina platforms, respectively; the other tools were not able to assemble complete genomes for these viruses. Although drVM produced distinct viral genome assemblies within the same genus, for human papillomavirus types 45 and 53 in SRR062073 ( Fig. 2 and Table 3 ) and for human enterovirus rhinovirus in the simula-tion dataset (Fig. 3) , the assembler may not be able to handle mixtures of very closely related viruses. Moreover, a biased viral reference database may result in assemblies with missing segments or no assembly whatsoever. Unlike SURPI and VIP, the coverage plots produced by drVM are created by mapping raw reads back to the assembled contigs, not to closelyrelated references. A coverage plot with a continuous profile reflects the accuracy and continuity of the assembly paradigm. With the support of coverage plot, one can rest assured that viruses with drVM-produced genome assemblies are present in the sample. Among SURPI, VIP, and VirusTAP, VirusTAP is the only user-friendly tool for viral genome assembly from metagenomic reads. The other two pipelines are not easily operated by users lacking advanced bioinformatics skills. Although academic users can access VirusTAP and obtain viral genomes with ease, the package is not suitable for assembling Ion Torrent data ( Table 3 , SRR1170797) and low-copy viruses ( Table 3, SRR062073) . Moreover, users are not able to update reference databases in VirusTAP, a web-based tool. Alternatively, drVM provides various images for Docker, Amazon, and Virtual Machine deployment and features a user-friendly interface (as shown in Fig. 2B ) in the Virtual Machine. drVM also generates self-explanatory results ( Fig. 2C and D) accurately and rapidly; it therefore is wellsuited for clinical applications. Although drVM operates in such a manner that the subtraction of the host read is neglected, which may produce valid host sequences annotated with viral references, this error can be easily identified via inspection of the assembled contigs. For example, analyzing SRR3031107 concatenated with SRR544883, a 1872-bp contig annotated with Feline leukemia virus gene for viral Notch2 (92% identity) actually corresponded to homo sapiens notch 2 (100% identity). Nevertheless, the provirus that integrated into a host genome is partial and it can be easily distinguished from the complete viral genome (Feline leukemia virus, genome size: 8.45 kbp) by length. We therefore recommend that conclusions drawn from drVM should be made with caution, especially with regards to retrovirus detection. We have applied drVM in the analyses of over 300 sequencing runs retrieved from NCBI's SRA to demonstrate that drVM is indeed able to efficiently produce genome assemblies for known eukaryotic viruses from metagenomic data. Project name: drVM Project home page: https://sourceforge.net/projects/sb2nhri/ files/drVM/ Operating system(s): OS X, Linux, Windows Programming language: Python Requirements: Amazon machine image, Docker, or Virtual machine; 8 GB RAM License: GNU General Public License, version 3.0 (GPL-3.0) Snapshots of the code and further supporting data is available in the GigaScience repository GigaDB [40] . AMI: Amazon machine image; HCV: hepatitis C virus; HIV: immunodeficiency virus; NGS: next-generation sequencing; RSV: respiratory syncytial virus; SRA: sequencing read archive; WNV: West Nile virus. NCBI viral genomes resource ViPR: an open bioinformatics database and analysis resource for virology research Unraveling the web of viroinformatics: computational tools and databases in virus research Outbreak of avian influenza A(H5N1) virus infection in Hong Kong in 1997 Studying immunity to zoonotic diseases in the natural host -keeping it real Ebola-a growing threat? Detection and sequencing of Zika virus from amniotic fluid of fetuses with microcephaly in Brazil: a case study A modified RNA-Seq approach for whole genome sequencing of RNA viruses from faecal and blood samples Evaluation of unbiased next-generation sequencing of RNA (RNA-seq) as a diagnostic method in influenza virus-positive respiratory samples A cloudcompatible bioinformatics pipeline for ultrarapid pathogen identification from next-generation sequencing of clinical samples Taxonomer: an interactive metagenomics analysis portal for universal pathogen detection and host mRNA expression profiling VIP: an integrated pipeline for metagenomics of virus identification and discovery VirusTAP: Viral genometargeted assembly pipeline Docker: lightweight Linux containers for consistent development and deployment Harnessing virtual machines to simplify next-generation DNA sequencing analysis Virus identification in unknown tropical febrile illness cases using deep sequencing A novel adenovirus species associated with an acute respiratory outbreak in a baboon colony and evidence of coincident human infection Identification of hepatotropic viruses from plasma using deep sequencing: a next generation diagnostic tool Complete viral RNA genome sequencing of ultra-low copy samples by sequenceindependent amplification Full genome virus detection in fecal samples using sensitive nucleic acid preparation, deep sequencing, and a novel iterative sequence classification algorithm Human papillomavirus community in healthy persons, defined by metagenomics analysis of human microbiome project shotgun sequencing data sets Simultaneous rapid sequencing of multiple RNA virus genomes Discovery of a novel human pegivirus in blood associated with hepatitis C virus coinfection Comparative analysis of the intestinal bacterial and RNA viral communities from sentinel birds placed on selected broiler chicken farms Rapid metagenomic identification of viral pathogens in clinical samples by real-time nanopore sequencing analysis Diverse array of new viral sequences identified in worldwide populations of the Asian citrus psyllid (Diaphorina citri) using viral metagenomics The intestinal eukaryotic virome in healthy and diarrhoeic neonatal piglets Faecal virome of red foxes from peri-urban areas Metagenomic analysis of viral genetic diversity in respiratory samples from children with severe acute respiratory infection in China Faster and more accurate sequence alignment with SNAP BLAST+: architecture and applications SPAdes: a new genome assembly algorithm and its applications to single-cell sequencing Tackling soil diversity with the assembly of large, complex metagenomes The khmer software package: enabling efficient nucleotide sequence analysis SOAP2: an improved ultrafast tool for short read alignment Ray meta: scalable de novo metagenome assembly and profiling Fast gapped-read alignment with Bowtie 2 Fast and accurate short read alignment with Burrows-Wheeler transform Fast and accurate long-read alignment with Burrows-Wheeler transform Supporting data for "drVM: a new tool for efficient genome assembly of known eukaryotic viruses from metagenomes" GigaScience Database This work was supported by grants (PH-105-PP-05) from the National Health Research Institute, Taiwan, and a research grant (MOST-104-2320-B-400-021-MY2) from the Ministry of Science and Technology, Taiwan. We would like to thank Bioinformatics Core Facility for Translational Medicine and Biotechnology Development (TMDB) and National Applied Research Laboratories (NARLabs) of Taiwan for providing computational facilities. Supplementary data are available at GIGSCI online. The authors declare that they have no competing interests. YCL conceived the project. HHL implemented the pipeline. YCL and HHL prepared, read, and approved the final manuscript.