Skip to main content
  • Software Article
  • Open access
  • Published:

Gen2Epi: an automated whole-genome sequencing pipeline for linking full genomes to antimicrobial susceptibility and molecular epidemiological data in Neisseria gonorrhoeae

Abstract

Background

Recent adva1nces in whole genome sequencing (WGS) based technologies have facilitated multi-step applications for predicting antimicrobial resistance (AMR) and investigating the molecular epidemiology of Neisseria gonorrhoeae. However, generating full scaffolds of N. gonorrhoeae genomes from short reads, and the assignment of molecular epidemiological information (NG-MLST, NG-MAST, and NG-STAR) to multiple assembled samples, is challenging due to required manual tasks such as annotating antimicrobial resistance determinants with standard nomenclature for a large number of genomes.

Results

We present Gen2Epi, a pipeline that assembles short reads into full scaffolds and automatically assigns molecular epidemiological and AMR information to the assembled genomes. Gen2Epi is a command-line tool integrating third-party software and tailored specifically for N. gonorrhoeae. For its evaluation, the Gen2Epi pipeline successfully assembled the WGS short reads from 1484 N. gonorrhoeae samples into full-length genomes for both chromosomes and plasmids and was able to assign in silico molecular determinant information to each dataset automatically. The assemblies were generated using raw as well as trimmed short reads. The median genome coverage of full-length scaffolds and “N” statistics (N50, NG50, and NGA50) were higher than, or comparable to, previously published results and the scaffolding process improved the quality of the draft genome assemblies. Molecular antimicrobial resistant (AMR) determinants identified by Gen2Epi reproduced information for the 1484 samples as previously reported, including NG-MLST, NG-MAST, and NG-STAR molecular sequence types.

Conclusions

Gen2Epi can be used to assemble short reads into full-length genomes and assign accurate molecular marker and AMR information automatically from NG-STAR, NG-MAST, and NG-MLST. Gen2Epi is publicly available under “CC BY-NC 2.0 CA” Creative Commons licensing as a VirtualBox image containing the constituent software components running on the LINUX operating system (CentOS 7). The image and associated documentation are available via anonymous FTP at ftp://www.cs.usask.ca/pub/combi or ftp://ftp.cs.usask.ca/pub/combi

Background

Gonorrhea, a sexually transmitted infection (STI) caused by Neisseria gonorrhoeae (Ng), is a global public health problem, magnified by high levels of resistance to antimicrobial agents [1]. The introduction of whole-genome sequencing (WGS) technologies has allowed the tracking of gonococcal transmission and resistance to all classes of available antimicrobials [2]. In order to manage and analyze the large amount of data generated from sequencing techniques, initiatives to develop appropriate tools and software have been undertaken by the N. gonorrhoeae scientific community worldwide [3] with a number of methods developed to assemble genomes, predict antimicrobial resistance (AMR), and investigate strain transmission through analysis of genomic molecular determinants.

A variety of bacterial strain typing facilities have been made available to the community. Jolly and Maiden initially developed BIGSdb (Bacterial Isolate Genome Sequence Database) [4] to store and investigate Multilocus Sequence Typing (MLST) profiles of sequences generated from multiple sources, such as multiple single amplicons or assembled contigs from sequencing technologies. The BIGSdb database was supplanted by pubMLST [5], which has been subsequently used by the scientific community to store and exploit WGS data for strain characterization. The web-based components of the pubMLST database [6] were implemented using MLST software [7]. Inouye et al. developed SRST [8] (Short Read Sequence Typing) software implemented for a number of bacteria (including N. gonorrhoeae) to determine sequence/strain type directly from short read WGS data. Molecular strain typing schemes for N. gonorrhoeae have also been developed based on molecular antimicrobial resistance determinants, such as the web-based NG-STAR (Neisseria gonorrhoeae Sequence Typing for Antimicrobial Resistance) [9] typing scheme. Although this web-based application allows batch upload of AMR gene sequences from multiple samples, bulk download of annotated antimicrobial resistance determinants is a manual process [10]. A third typing procedure, called NG-MAST (N. gonorrhoeae Multiantigen Sequence Typing), is based on the sequences of two highly variable genes, porB, and tbpB [11]. Martin et al. [12] developed a publicly available database of sequences of porB and tbpB alleles, which was utilized to build a command-line software tool named NGMASTER to assign NG-MAST strain types to whole genome assemblies [13]. All these individual typing schemes give a comprehensive picture of N. gonorrhoeae strain characterization; however, until the present, there has been no publicly available tool or software available to consolidate these various typing schemes at one place.

Several experiments describe the use of WGS assemblies to understand the molecular epidemiology of gonococcal isolates [14,15,16,17,18], including recently published Australian [15], New Zealand [14] and EuroGASP 2013 [18] studies. These analyses [14,15,16] terminated the N. gonorrhoeae WGS assembly process at the level of contigs. A disadvantage of this approach is the possibility of missing a gene during gene identification or making an error in the number of predicted genes due to gene fragmentation over multiple contigs. Despite the presence of scaffolding tools, none of the previously published WGS studies assembled contigs into full genomes, except in one study where authors used PacBio long reads to assemble N. gonorrhoeae World Health Organization (WHO) reference strains [17], and a second study recently published by Harris et al. [18], which used SPAdes [19] along with the Sanger Institute assembly pipeline [20] to assemble short reads into scaffolds. The entire dataset generated by the European genomic survey [18] has been made available at the Pathogenwatch website [21]. The website allows users to access full genomes from different bacterial species along with investigative methods such as MLST analysis, AMR predictions, genome clustering, and interactive visualization. However, a shortcoming of this web application [21] is the lack of important analysis steps such as data cleaning, de novo assembly, scaffolding, and annotation.

There have been a number of methods and pipelines developed to assemble bacterial contigs into scaffolds; for instance, Ragout [22], SSPACE [23], SSPACE-LongRead [24], and ALLPATHS [25]. The Sanger Institute assembly pipeline [20] improves assembly by joining assembled contigs into scaffolds but it lacks further downstream analysis such as annotation, strain typing, and AMR prediction.

In published studies for N. gonorrhoeae, different assemblers, pipelines, and web applications have been utilized to analyze the genomes [14, 26,27,28]. Among the frequently used techniques are SPAdes [19], Velvet [26, 27], and CLC Workbench [28]. Another commonly used method in the Neisseria community is the Nullarbor pipeline, which performs complete analysis, from read cleaning to variant calling [29]. However, it lacks NG-MAST and NG-STAR typing schemes.

Despite the advances in WGS techniques, generating full scaffolds of N. gonorrhoeae genomes from assembled short reads, and the assignment of in silico molecular marker information to multiple samples, is challenging due to required, typically manual steps, such as annotating antimicrobial resistance determinants with the standard nomenclature for a large number of genomes. Here, we present a one-step computational WGS pipeline, named Gen2Epi, to 1) assemble short read datasets into full-length genomes, and 2) assign molecular epidemiological and AMR designations to the assembled genomes automatically. We assessed the performance of the Gen2Epi pipeline by using Illumina short reads from 1484 whole genome sequencing samples from previously published studies [14, 17, 18, 30, 31] and also determined the accuracy by comparing to previously reported results [14, 17, 18, 30, 31]. Our long-term goal is to make this a user-friendly pipeline readily accessible to public health researchers not familiar with in-depth bioinformatics approaches.

Implementation

Data used

The Gene2Epi pipeline was tested using 1484 N. gonorrhoeae sequencing-read datasets from previously published studies (Additional file 1: Table S1) [14, 17, 18, 30, 31]. The first study included WHO N. gonorrhoeae reference strains (WHO F, G, K, L, M, N, O, P, X, Y, and Z) [17]. Full reference genomes of these strains were available at the European Nucleotide Archive (ENA) [32] (Additional file 1: Table S1). The second study included 27 isolates that originated from patients in Saskatchewan, Canada [30, 31]. The third and fourth studies included 398 N. gonorrhoeae datasets from New Zealand [14] and 1048 isolates from the EuroGASP 2013 collection [18] downloaded from National Center for Biotechnology Information (NCBI) [33]. Six samples were excluded from the 1054 WGS samples in the original EuroGASP study (see Additional file 1: Table S1 for more information). WGS data available from all these studies were generated on Illumina platforms (Additional file 1: Table S1). NCCP11945 and FA1090 N. gonorrhoeae reference genomes were downloaded from the NCBI [33]. Sequences of known N. gonorrhoeae plasmids (see Additional file 1: Table S2 for references) and NG-MLST and NG-STAR genes (Additional file 1: Table S2) were downloaded from the NCBI public nucleotide repository [33]. MLST allelic sequences and profiles were retrieved from pubMLST (July 4, 2018) [6]. FASTA sequences of NG-STAR [7] allele sequences, as well as profile and metadata associated with seven AMR genes, were downloaded from the NG-STAR website (July 4, 2018) [10].

During Gen2Epi testing, a number of reference genomes were utilized for the scaffolding process. For instance, available WHO reference genomes were used in the case of WHO datasets [17], N. gonorrhoeae NCCP11945 for New Zealand [14] isolates, and N. gonorrhoeae FA1090 N. gonorrhoeae reference strain genomes for Saskatchewan [30, 31] and EuroGASP 2013 [18] isolates (see Additional file 1: Table S1). The WHO sequencing read datasets along with reference genomes, Ng plasmid sequences, AMR gene sequences, allelic sequences with their profiles and metadata for NG-MLST and NG-STAR along with locally created databases of Ng plasmid sequences (Additional file 1: Table S2) and MLST allelic sequences are provided in the Gen2Epi VirtualBox image. The NG-MAST alleles datasets are already been provided with the NGMASTER program [13].

Pipeline infrastructure

Gen2Epi is a Linux-based command-line pipeline providing fully integrated analysis to assemble reads to scaffolds and link the assembled genomes to strain typing (NG-MLST and NG-MAST) and AMR determinant (NG-STAR) information in one place. The pipeline design integrates third-party software (Additional file 1: Table S3) and in-house Perl scripts. All software dependencies are freely available under general public license. Integration of different components is facilitated by using standard input and output formats such as FASTQ, FASTA, plain text, and BLAST report. The architecture of the pipeline has been implemented in five main modules (Fig. 1) consisting of 1) data cleaning; 2) de novo assembly of chromosomes and plasmids; 3) scaffolding, annotation, and quality evaluation; 4) plasmid-type identification (see Additional file 1: Table S2); and 5) molecular epidemiological and AMR determinant prediction. Complete documentation (user manual), along with the pipeline source code can be found at ftp://www.cs.usask.ca/pub/combi or ftp://ftp.cs.usask.ca/pub/combi. Each sequential step of the pipeline are automatic, linked with each other and described below.

Fig. 1
figure 1

A flowchart outlining the design of the Gen2Epi pipeline with integrated third-party software. Pipeline design sections highlighted in orange color are implemented via custom scripts

Step 1: Data Cleaning

Prior to genome assembly, removing adapter sequences and low-quality bases from the raw FASTQ reads is common practice. In Gen2Epi, input raw read datasets in FASTQ format are trimmed to remove low-quality reads (at phred score Q15) using Trimmomatic [34] after an initial quality check using FastQC [35]. Mismatched reads are not currently eliminated. FastQC results for multiple samples (WGS data generated from multiple Ng isolates) are merged into one report using MultiQC [36]. The program does data cleaning automatically in a single step. Furthermore, functions for contamination checks and raw read mapping to the N. gonorrhoeae reference genomes are implemented using Kraken [37] and Bowtie2 [38]. The pipeline allows users to customize the combination of these tools applied to clean the raw reads in this step (see Additional file 2: Technical details). For users who do not want to trim the reads, this step can be skipped by directly using the raw dataset in step two for de novo assembly.

Step 2: De novo assembly of chromosome and plasmid

In the second stage, the output from step one is used to generate contigs using separate de novo assemblies of chromosomes and plasmids. Raw or trimmed reads are assembled into contigs using SPAdes [18] (“--k 21, 33, 55, 77, 99, 127”, “--pe1–1”, “--pe1–2”, “--careful” and “--cov-cutoff auto”), whereas plasmid reads are assembled into contigs with plasmidSPAdes [39] (SPAdes with parameters “--plasmid”, “--pe1–1”, “--pe1–2”, “--careful” and “--cov-cutoff auto”). In addition, this step also utilizes the “stats.sh” function from BBMap [40] to generate a contig assembly statistics report of the assembled contigs. The resulting contigs can be directly imported into the next step.

Step 3: Scaffolding, annotation, and quality evaluation

In this step, assembled contigs (in FASTA format) from step two are joined into full scaffolds by using the reference-based scaffolding approach implemented in Ragout [22]. The resulting scaffolds (FASTA files) are subjected to gene prediction using Prodigal [41]. The quality of the assembled scaffolds is then assessed by comparison with the respective reference genome for potential misassembled and chimeric contigs using QUAST [42]. The completeness of the assembled genomes can also be assessed via optional manual examination of the multiple alignments of scaffolds with the respective N. gonorrhoeae reference genome in Mauve [43].

Step 4: Plasmid-type Identification

Assembled plasmid contigs generated from step two are aligned against a built-in database of plasmid sequences using NCBI BLASTN [44] to identify the plasmid type. An optional script carries out this step. The built-in database contains the sequences of eight N. gonorrhoeae plasmids (including six β-lactamase, conjugative, conjugative tetM, and cryptic plasmids) (see Additional file 1: Table S2).

Step 5: Molecular epidemiological analysis and AMR determinant predictions

This step implements the combination of three N. gonorrhoeae strain-typing schemes. To achieve this, NG-MAST types are assigned directly from full scaffolds using NGMASTER [13]. In order to characterize strains according to the NG-MLST scheme, a locally created database of annotated genes (created automatically by the script) from each sample is queried using the MLST nucleotide sequences. The resulting MLST genes identified from each scaffold are further used as queries against a built-in database of MLST allelic sequences (from pubMLST on July 4, 2018 [6]) using BLASTN in order to assign allelic types to them. The alignment output is parsed and analyzed, and the sequence type and clonal complex information from a combination of MLST gene alleles from each sample are subsequently retrieved from the MLST profiles.

To perform NG-STAR typing, AMR genes (Additional file 1: Table S2) are extracted by aligning them against a locally created database of individual scaffolds (created automatically by the script) from every sample using BLASTN [44] and functions imported from the EMBOSS toolkit [45]. The respective sequence type (ST) and nomenclature of N. gonorrhoeae loci associated with AMR are assigned to each allelic combination by searching against AMR gene profiles and metadata (downloaded from NG-STAR website on July 4, 2018 [10] and provided as part of Gen2Epi).

All three typing schemes (NG-MAST, NG-MLST and NG-STAR), along with alignment and parsing, are carried out using a single custom script. The WHO sequencing read datasets and reference genomes, along with locally created plasmid databases used in step 4, are included within the Gen2Epi distribution.

Results and discussion

Gen2Epi assembles short reads into full genomes

The Gen2Epi pipeline successfully assembled the short reads from 1484 N. gonorrhoeae WGS samples into full-length genomes. Using the recommended hardware configuration (see Availability and Requirements below), full analysis required approximately 12 h of elapsed time to complete on a laptop with a 3.60 GHz Intel(R) processor. The detailed results of the full genome assembly evaluation in terms of measures such as median misassemblies, alignment length, and different “N” statistics (N50, NA50, NG50, and NGA50 [42]) are shown in Table 1. In contrast to Saskatchewan, New Zealand [14] and EuroGASP 2013 isolates [18], full genomes generated using WHO reference strains had higher NGA50 with no misassemblies, which suggests that, in the case of WHO reference strain isolates [17], the assembled genomes (generated by using trimmed reads) were nearly perfect (Additional file 3: Figure S1). The other striking difference among results generated from the data from these four studies using the Gen2Epi pipeline is that the median genome coverage of full-length scaffolds of WHO isolates [17] was higher (95.95%) than for Saskatchewan [30, 31] (93.88%), New Zealand [14] (92.33%) and EuroGASP 2013 isolates [18] (92.62%). The reason for nearly perfect scaffolds (higher genome coverage) in WHO isolates is the use of existing full reference genomes for each sample.

Table 1 Evaluation of the genome assemblies. Measures are median values

To compare the completeness of the genomes generated by Gen2Epi with published results, optimally fully assembled genomes from these previously published studies should be used [14, 17, 18, 30, 31]. However, due to the unavailability of such full genomes (with the exception of a WHO study [17]), we could not make this comparison. In the case of Saskatchewan and New Zealand isolates [30, 31], the assemblies were terminated at the level of contigs. For the EuroGASP 2013 isolates, the authors assembled the reads into multiple scaffolds per genome. The unavailability of these scaffolds as single sequences made it difficult to use them for comparison. However, some comparisons were possible. The “N” statistics values reported for Gen2Epi in the case of the New Zealand samples were higher than previously published values (N50: 40970, NG50: 40198, and NGA50: 35250) [14]. This shows that the use of scaffolding is capable of improving draft genome assemblies generated from short reads. Moreover, the median genome coverage by Gen2Epi in the case of the New Zealand isolates was 92.3%, lower than the previously published result (93.5%) [14]. The probable reason behind this result is that Lee et al. [14] used raw reads to map against the N. gonorrhoeae NCCP11945 genome, whereas Gen2Epi aligned scaffolds.

Even though full genomes generated by the proposed pipeline were accurate and overcame the limitation of gene fragmentation over multiple contigs, there were still some irregularities (see Additional file 1: Table S4C where missing AMR genes are represented with “NA”) that can be seen in the results. A characteristic of the pipeline is that it filters out assembled contigs having low-quality bases and contamination during the scaffolding process, occasionally resulting in important AMR genes (such as 23S rRNA) being missing from the molecular marker identification and AMR analysis step. This occurred in the case of the irregularities noted in Table S4C (Additional file 1: Table S4C), supporting the notion that the accuracy and completeness of the final assembled genome is highly dependent upon the quality of the input dataset. Furthermore, we could not compare these irregularities with the previous work as, except for the Saskatchewan isolates [30, 31], none of the published studies [14, 17, 18] used in this analysis performed NG-STAR typing.

Trimming is one of the most effective methods to remove the poor quality bases at the end of the reads from input datasets as error introduced during sequencing cycles by the Illumina sequencing platform often leads to degradation in base quality [46]. The effects of trimming were most apparent in the current analysis when contigs generated from trimmed reads were compared with those generated from raw reads, as in the case of the Saskatchewan and EuroGASP 2013 isolates. A previous study [47] showed that read trimming has effects on genome assembly in terms of average assembly length, largest scaffolds and “N” statistics. We also observed these partial negative effects in one case (sample 32,657 from the Saskatchewan isolates) where a large number of reads were filtered out during the trimming process and consequently very few contigs (# contigs = 3) were assembled. In the case of EuroGASP 2013 isolates, differences were observed in three samples (ERR147119, ERR1560830, and ERR1469562) where STs were different from those previously reported by the authors (see the next section for further explanation).

Accuracy in automatic assignment of molecular epidemiological markers and AMR determinants

To assess the accuracy of in silico molecular epidemiological markers and AMR determinants generated by the Gen2Epi pipeline, we first analyzed the strain typing results from published studies that have used one or all of the three typing schemes (Table 2). The Saskatchewan study [30, 31] used all three typing schemes, while in the case of New Zealand samples [14], only NG-MAST results were reported. For the original WHO reference strains study, NG-MAST and NG-MLST were performed to characterize them phenotypically [17]. For the EuroGASP 2013 isolates [18], authors performed NG-MAST and NG-MLST typing schemes. Gen2Epi not only generated the same strain type and AMR marker information (with a few minor explainable exceptions – please see next paragraph for details) as reported previously for the 1484 samples but also was able to automatically and simultaneously assign these molecular epidemiological marker results from NG-MLST [5], NG-MAST [11] and NG-STAR [9]. Sample output generated by the Gen2Epi AMR & Molecular Epidemiological Analysis step is shown in Additional file 1: Table S4.

Table 2 AMR and molecular epidemiological results

In the case of the Saskatchewan isolates, the NG-STAR results for 12 isolates are 100% identical to the previously published results; information for the remaining 15 isolates is not given in the original publications [30, 31]. For the EuroGASP 2013 isolates (Table 2) [18], using Gen2Epi we were able to assign the isolates to the same 377 NG-MAST sequence types as previously reported [18]. Out of 1048 isolates, 1022 (98%) were exact matches while 26 samples (2%) showed variation. Out of 26 samples, Gen2Epi assigned either an ST number or “new” ST to the 17 isolates that were reported as “multiple” ST in the previous study [18]. Two isolates with a new ST now have a number (one has an ST number [16219] whereas another has a Tbpb allele number [2597]). Gen2Epi was unable to assign STs to the remaining 7 samples (out of 26 isolates) due to missing AMR genes (because of filtering of these genes during the scaffolding process). Moreover, 102 MLST sequence types were identical between the published results of EuroGASP (where a total of 103 MLST STs were reported) and the results produced by Gen2Epi. We observed that three samples (ERR147119, ERR1560830, and ERR1469562) had different STs than previously reported by the authors. To find the reason behind these differences, we reanalyzed these samples directly using raw reads. Consequently, we were able to assign the same ST (assigned in published studies) to sample ERR1469562. However, for samples ERR147119 and ERR1560830, the predicted STs were still different from the published ones. In addition, we observed the presence of “NA” occasionally in the NG-STAR output (Additional file 1: Table S4C) due to the filtering of AMR genes with low-quality bases during the scaffolding process. This finding indicates that the effect of data trimming on genome assemblies should be studied in detail.

Gen2Epi pipeline validation

The pipeline was validated by one of the authors (Demczuk) at a separate site (National Microbiology Laboratory, Public Health Agency, Winnipeg) by analyzing  the WHO  N. gonorrhoeae reference strains (the WGS isolates are provided in the Gen2Epi VirtualBox image) and obtaining identical results.

Comparison with existing pipelines and available tools

We compared the Gen2Epi pipeline with existing tools developed using different techniques and exhibiting various features, and which have been widely used by the N. gonorrhoeae research community. The detailed comparison is shown in Table 3. Some highlights are as follows.

Table 3 Comparison of functions and features of different tools commonly used by the N. gonorrhoeae scientific community

Firstly, in terms of functional features, both the Gen2Epi and Nullarbor pipelines can perform data cleaning and contamination checks on the raw reads. For assembly, four tools (Gen2Epi, Nullarbor [29], Patric [48], and Sanger pipeline [20]) can de novo assemble raw reads into contigs. However, only Gen2Epi, Patric, and the Sanger pipeline can perform scaffolding on the assembled contigs. In addition, neither Patric nor the Sanger pipeline contains a read-mapping feature. Five tools (Nullarbor pipeline [29], Pathogenwatch [21], pubMLST [6], Patric [48], and SRST [8]) can identify the NG-MLST strain type from assembled contigs/short-reads/MLST genes. NG-MAST [12], NGMASTER [13], and NG-STAR [10] can extract Multiantigen Sequence Typing (MLST) and AMR determinant information. Therefore, when using the latter existing tools, users have to turn to each alternative tool separately to obtain the strain typing information from their WGS data, but Gen2Epi can directly link all this information in one place.

Secondly, all of these tools fall into two groups based on their user interface. Tools such as Gen2Epi, Sanger pipeline, Nullarbor, SRST, and NGMASTER in the first group have a command-line interface. In the second group, tools such as Patric, pubMLST, NG-MAST, Pathogenwatch, and NG-STAR are web-based applications that are convenient to use but may be frustrating or impractical when users have to deal with a large dataset, especially in cases of manual retrieval of the final outcomes. Taking convenience and flexibility into consideration, Gen2Epi provides complete WGS analysis in five simple steps and provides results in a ready-to-use format.

Thirdly, the input and output formats are quite different among the existing tools and software. For input files, the Nullarbor, Sanger pipeline, and SRST tools typically require a tab-limited text file, genomes in FASTA format, assembly in FASTA format, and reads in a FASTQ format for both forward and reverse orientations. Only FASTQ files are required as an input for Patric. In contrast, all of the three strain typing tools (pubMLST, NG-MAST, and NG-MLST) require AMR genes identified from the assembled contigs in FASTA format. Gen2Epi requires input data in FASTQ (raw or trimmed readsets) and FASTA formats.

Finally, the biggest limitation with both NG-MAST and NG-STAR is that these tools do not use assembled contigs or scaffolds to determine strain typing and AMR determinants. Gen2Epi overcomes this limitation by allowing users to determine strain typing directly from assembled scaffolds and predicted genes. Therefore, Gen2Epi is superior in comparison because it enables users to assemble multiple samples efficiently into scaffolds and assign molecular epidemiological results automatically and simultaneously.

Functions for variant calling, mismatched read elimination, novel AMR determinant prediction, assembly improvement using long reads, and scripts that can take advantage of API (Application Programming Interface) facilities implemented in pubMLST, will be included in the next version. Modules for phylogeny based on core genome analysis [49] will also be implemented in next release as a previous study [50] showed that typing based phylogenetic analysis often leads to a less resolved tree, and that this limitation can be overcome by performing the analysis on a genome-wide scale. In order to make Gen2Epi easy to use for the clinician, a Graphical User Interface (GUI) will be implemented in a future release. It will make use of freely available perl or python libraries so as to be portable and platform independent.

The first two steps (Data Cleaning, De novo assembly of Chromosome and Plasmid, and Plasmid-type Identification) of the current Gen2Epi version are universal for the analysis of other pathogenic bacteria such as Chlamydia trachomatis, N. meningitidis, and Mycobacterium tuberculosis. However, functions for the complete WGS analysis (including novel scaffolding and typing scripts) of other bacteria will be implemented in the future GUI version of Gen2Epi.

Conclusions

We have developed a novel WGS pipeline named Gen2Epi to assemble Illumina short reads to full genomes and assign strain typing (NG-MAST and NG-MLST) and AMR determinant information (NG-STAR) automatically to the assembled genomes. The accuracy of the pipeline was validated by testing it on 1484 N. gonorrhoeae isolates from four previously published studies [14, 17, 18, 30, 31]. Comparison with existing tools indicated that Gen2Epi outperformed in both functional features and handling multiple samples simultaneously. Furthermore, the pipeline works well both with raw reads and trimmed readsets. Gen2Epi is intended to generate strain typing and AMR determinant output results that are easy to handle with less manual effort.

Availability and requirements

Project name: Gen2Epi.

Project homepage: Anonymous ftp from URL ftp://www.cs.usask.ca/pub/combi. Any standard web browser can be used to access this site.

Operating system(s): Platform Independent.

Programming language: Perl.

Other requirements: VirtualBox 5.2.14 or higher. The Gen2Epi virtual machine requires a minimum of 29 GB of free hard drive space, 2 GB of RAM, and 2 processors to efficiently run the pipeline on the test dataset included with the software distribution. With this virtual machine configuration on a computer with a 3.6GHz CPU, approximately 12 h of elapsed time are required to complete the full analysis of the test data.

License: CC BY-NC 2.0 CA.

Abbreviations

AMR:

antimicrobial resistance

API:

Application Programming Interface

BIGSdb:

Bacterial Isolate Genome Sequence Database

ENA:

European Nucleotide Archive

MLST:

Multilocus Sequence Typing

NCBI:

National Center for Biotechnology Information

Ng:

Neisseria gonorrhoeae

NG-MAST:

N. gonorrhoeae Multiantigen Sequence Typing

NG-STAR:

Neisseria gonorrhoeae Sequence Typing for Antimicrobial Resistance

SRST:

Short Read Sequence Typing

ST:

Sequence Type

STI:

sexually transmitted infection

WGS:

whole genome sequencing

WHO:

World Health Organization

References

  1. Lahra MM, Dillon JAR, George CRR, Lewis DA, Wi TE, Whiley DM. From zero to zero in 100 years: gonococcal antimicrobial resistance. Microbiol Aust. 2016;37:173–6.

    Article  Google Scholar 

  2. Abrams AJ, Trees DL. Genomic sequencing of Neisseria gonorrhoeae to respond to the urgent threat of antimicrobial-resistant gonorrhea. Pathog Dis. 2017;75(4).

  3. Harrison OB, Schoen C, Retchless AC, Wang X, Jolley KA, Bray JE, et al. Neisseria genomics: current status and future perspectives. Pathog Dis. 2017;75(6).

  4. Jolley KA, Maiden MCJ. BIGSdb: scalable analysis of bacterial genome variation at the population level. BMC Bioinformatics. 2010;11:595.

    Article  PubMed  PubMed Central  Google Scholar 

  5. Jolley KA, Maiden MC. Automated extraction of typing information for bacterial pathogens from whole genome sequence data: Neisseria meningitidis as an exemplar. Eurosurveillance. 2013;18:41–9.

    Article  Google Scholar 

  6. PubMLST [https://pubmlst.org/]. Accessed 4 July 2018.

  7. Seemann T, mlst [https://github.com/tseemann/mlst]. Accessed 6 September 2018.

  8. Inouye M, Conway TC, Zobel J, Holt KE. Short read sequence typing (SRST): multi-locus sequence types from short reads. BMC Genomics. 2012;13:338.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  9. Demczuk W, Sidhu S, Unemo M, Whiley DM, Allen VG, Dillon JR, et al. Neisseria gonorrhoeae sequence typing for antimicrobial resistance, a novel antimicrobial resistance multilocus typing scheme for tracking global dissemination of N. gonorrhoeae strains. J Clin Microbiol. 2017;55:1454–68.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  10. NG_STAR [https://ngstar.canada.ca/welcome/home]. Accessed on 4 July 2018.

  11. Martin IM, Ison CA, Aanensen DM, Fenton KA, Spratt BG. Rapid sequence-based identification of gonococcal transmission clusters in a large metropolitan area. J Infect Dis. 2004;189:1497–505.

    Article  CAS  PubMed  Google Scholar 

  12. NG-MAST [http://www.ng-mast.net/]. Accessed on 10 July 2018.

  13. Kwong JC, Gonçalves da Silva A, Dyet K, Williamson DA, Stinear TP, Howden BP, et al. NGMASTER: in silico multi-antigen sequence typing for Neisseria gonorrhoeae. Microb Genomics. 2016;2(8):e000076.

    Article  Google Scholar 

  14. Lee RS, Seemann T, Heffernan H, Kwong JC, Gonçalves da Silva A, Carter GP, et al. Genomic epidemiology and antimicrobial resistance of Neisseria gonorrhoeae in New Zealand. J Antimicrob Chemoth. 2018;73:353–64.

    Article  CAS  Google Scholar 

  15. Al Suwayyid BA, Coombs GW, Speers DJ, Pearson J, Wise MJ, Kahler CM. Genomic epidemiology and population structure of Neisseria gonorrhoeae from remote highly endemic Western Australian populations. BMC Genomics. 2018;19(1):165.

    Article  PubMed  PubMed Central  Google Scholar 

  16. Vidovic S, Caron C, Taheri A, Thakur SD, Read TD, Kusalik A, et al. Using crude whole-genome assemblies of Neisseria gonorrhoeae as a platform for strain analysis: clonal spread of gonorrhea infection in Saskatchewan, Canada. J Clin Microbiol. 2014;52:3772–6.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  17. Unemo M, Golparian D, Sánchez-Busó L, Grad Y, Jacobsson S, Ohnishi M, et al. The novel 2016 WHO Neisseria gonorrhoeae reference strains for global quality assurance of laboratory investigations: phenotypic, genetic and reference genome characterization. J Antimicrob Chemoth. 2016;71:3096–108.

    Article  CAS  Google Scholar 

  18. Harris SR, Cole MJ, Spiteri G, Sánchez-Busó L, Golparian D, Jacobsson S, et al. Public health surveillance of multidrug-resistant clones of Neisseria gonorrhoeae in Europe: a genomic survey. Lancet Infect Dis. 2018;18:758–68.

    Article  PubMed  PubMed Central  Google Scholar 

  19. Bankevich A, Nurk S, Antipov D, Gurevich AA, Dvorkin M, Kulikov AS, et al. SPAdes: a new genome assembly algorithm and its applications to single-cell sequencing. J Comput Biol. 2012;19:455–77.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  20. Page AJ, De Silva N, Hunt M, Quail MA, Parkhill J, Harris SR, et al. Robust high-throughput prokaryote de novo assembly and improvement pipeline for Illumina data. Microb Genomics. 2016;2(8):e000083.

    Article  Google Scholar 

  21. Pathogenwatch [https://pathogen.watch/]- Accessed on 7 September 2018.

  22. Kolmogorov M, Raney B, Paten B, Pham S. Ragout-a reference-assisted assembly tool for bacterial genomes. Bioinformatics. 2014;30:i302–9.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  23. Boetzer M, Henkel CV, Jansen HJ, Butler D, Pirovano W. Scaffolding pre-assembled contigs using SSPACE. Bioinformatics. 2011;27:578–9.

    Article  CAS  PubMed  Google Scholar 

  24. Boetzer M, Pirovano W. SSPACE-LongRead: scaffolding bacterial draft genomes using long read sequence information. BMC Bioinformatics. 2014;15:211.

    Article  PubMed  PubMed Central  Google Scholar 

  25. Butler J, MacCallum I, Kleber M, Shlyakhter IA, Belmonte MK, Lander ES, et al. ALLPATHS: De novo assembly of whole-genome shotgun microreads. Genome Res. 2008;18:810–20.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  26. Zerbino DR, Birney E. Velvet: algorithms for de novo short read assembly using de Bruijn graphs. Genome Res. 2008;18:821–9.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  27. Ezewudo MN, Joseph SJ, Castillo-Ramirez S, Dean D, Del Rio C, Didelot X, et al. Population structure of Neisseria gonorrhoeae based on whole genome data and its relationship with antibiotic resistance. PeerJ. 2015;3:e806.

    Article  PubMed  PubMed Central  Google Scholar 

  28. CLC Workbench[https://www.qiagenbioinformatics.com/products/clc-main-workbench/]. Accessed on 6 September 2018.

  29. Seemann T, Goncalves da Silva A, Bulach DM, Schultz MB, Kwong JC, Howden BP Nullarbor [ https://github.com/tseemann/nullarbor]. Accessed on 6 September 2018.

  30. Demczuk W, Lynch T, Martin I, Van Domselaar G, Graham M, Bharat A, et al. Whole-genome Phylogenomic heterogeneity of Neisseria gonorrhoeae isolates with decreased cephalosporin susceptibility collected in Canada between 1989 and 2013. J Clin Microbiol. 2015;53:191–200.

    Article  PubMed  Google Scholar 

  31. Demczuk W, Martin I, Peterson S, Bharat A, Van Domselaar G, Graham M, et al. Genomic epidemiology and molecular resistance mechanisms of azithromycin-resistant Neisseria gonorrhoeae in Canada from 1997 to 2014. J Clin Microbiol. 2016;54:1304–13.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  32. Leinonen R, Akhtar R, Birney E, Bower L, Cerdeno-Tárraga A, Cheng Y, et al. The European nucleotide archive. Nucleic Acids Res. 2011;39:D28–31.

    Article  CAS  PubMed  Google Scholar 

  33. Agarwala R, Barrett T, Beck J, Benson DA, Bollin C, Bolton E, et al. Database resources of the National Center for biotechnology information. Nucleic Acids Res. 2018;46:D8–D13.

    Article  Google Scholar 

  34. Bolger AM, Lohse M, Usadel B. Trimmomatic: a flexible trimmer for Illumina sequence data. Bioinformatics. 2014;30:2114–20.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  35. FastQC [https://www.bioinformatics.babraham.ac.uk/projects/fastqc]. Accessed on 11 May 2017.

  36. Ewels P, Magnusson M, Lundin S, Käller M. MultiQC: summarize analysis results for multiple tools and samples in a single report. Bioinformatics. 2016;32:3047–8.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  37. Wood DE, Salzberg SL. Kraken:ultrafast metagenomic sequence classification using exact alignments. Genome Biol. 2014;15(3):R46.

    Article  PubMed  PubMed Central  Google Scholar 

  38. Langmead B, Salzberg SL. Fast gapped-read alignment with bowtie 2. Nat Methods. 2012;9:357–U54.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  39. Antipov D, Hartwick N, Shen M, Raiko M, Lapidus A, Pevzner PA. plasmidSPAdes: assembling plasmids from whole genome sequencing data. Bioinformatics. 2016;32(22):3380–7.

    CAS  PubMed  Google Scholar 

  40. Bbmap [https://sourceforge.net/projects/bbmap/]. Accessed on 16 October 2017.

  41. Hyatt D, Chen GL, Locascio PF, Land ML, Larimer FW, Hauser LJ. Prodigal: prokaryotic gene recognition and translation initiation site identification. BMC Bioinformatics. 2010;11:119.

    Article  PubMed  PubMed Central  Google Scholar 

  42. Gurevich A, Saveliev V, Vyahhi N, Tesler G. QUAST: quality assessment tool for genome assemblies. Bioinformatics. 2013;29:1072–5.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  43. Darling ACE, Mau B, Blattner FR, Mauve PNT. Multiple alignment of conserved genomic sequence with rearrangements. Genome Res. 2004;14:1394–403.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  44. Camacho C, Coulouris G, Avagyan V, Ma N, Papadopoulos J, Bealer K, et al. BLAST plus : architecture and applications. BMC Bioinformatics. 2009;10:421.

    Article  PubMed  PubMed Central  Google Scholar 

  45. Rice P, Longden I, Bleasby A. EMBOSS: the European molecular biology open software suite. Trends Genet. 2000;16(6):276–7.

    Article  CAS  PubMed  Google Scholar 

  46. Fuller CW, Middendorf LR, Benner SA, Church GM, Harris T, Huang X, et al. The challenges of sequencing by synthesis. Nat Biotechnol. 2009;27(11):1013–23.

    Article  CAS  PubMed  Google Scholar 

  47. Del Fabbro C, Scalabrin S, Morgante M, Giorgi FM. An extensive evaluation of Read trimming effects on Illumina NGS data analysis. PLoS One. 2013;8(12):e85024.

    Article  PubMed  PubMed Central  Google Scholar 

  48. Wattam AR, Abraham D, Dalay O, Disz TL, Driscoll T, Gabbard JL, et al. PATRIC, the bacterial bioinformatics database and analysis resource. Nucleic Acids Res. 2014;42(Database issue):D581–91.

    Article  CAS  PubMed  Google Scholar 

  49. Harrison OB, Skett J, McLean J, Trees D, Sunkavalli A, Lourenço AP, et al. Using the Neisseria gonorrhoeae core genome to examine gonococcal populations. Oral session presented at: 21st International Pathogenic Neisseria Conference; 2018 Sep 23–28;Asilomar, California.

  50. Tsang AKL, Lee HH, Yiu SM, Lau SKP, Woo PCY. Failure of phylogeny inferred from multilocus sequence typing to represent bacterial phylogeny. Sci Rep. 2017;7:4536.

    Article  PubMed  PubMed Central  Google Scholar 

Download references

Acknowledgments

We thank Kopas Logan (Department of Computer Science, University of Saskatchewan) for beta testing Gen2Epi.

Funding

This work was supported by Canadian Institutes of Health Research (CIHR) (grant #418246) and funding by the University of Saskatchewan to JRD. The funding bodies had no role in the design or execution of the study.

Availability of data and materials

The complete pipeline, along with documentation, is available to the research community as a VirtualBox image running the CENTOS 7 operating system at ftp://www.cs.usask.ca/pub/combi or ftp://ftp.cs.usask.ca/pub/combi. The pipeline is distributed under “CC BY-NC 2.0 CA” Creative Commons license with no restriction to use by non-academics. The datasets used and analyzed during the current study are available at the above-mentioned website.

Author information

Authors and Affiliations

Authors

Contributions

JRD and AK conceived of this study. RS designed and developed the pipeline. RS analyzed the data and wrote the manuscript. WD provided the WHO reference strains and Saskatchewan isolates, and evaluated the pipeline and provided valuable feedback that has been implemented in the current version of Gen2Epi. All authors reviewed, edited and approved the final manuscript.

Corresponding authors

Correspondence to Jo-Anne R. Dillon or Anthony Kusalik.

Ethics declarations

Ethics approval and consent to participate

Not Applicable.

Consent for publication

Not Applicable.

Competing interests

The authors declare that they have no competing interests.

Publisher’s Note

Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Additional files

Additional file 1:

Table S1. Datasets used for pipeline testing and evaluation. Table S2. Names and accession numbers of input data used by the Gen2Epi pipeline. Table S3. List of third-party software incorporated into Gen2Epi. Table S4. Sample output generated from Gen2Epi’s AMR & Molecular Epidemiological Analysis step shown in tabular form. (DOCX 25 kb)

Additional file 2:

Technical details. (DOCX 20 kb)

Additional file 3:

Figure S1. Genome alignment of the Gen2Epi-produced WHO G scaffold against the corresponding Neisseria gonorrhoeae reference genome using Mauve. The extent of the colored bar indicates the strong similarity between the scaffold and the reference genome. (DOCX 48 kb)

Rights and permissions

Open Access This article is distributed under the terms of the Creative Commons Attribution 4.0 International License (http://creativecommons.org/licenses/by/4.0/), which permits unrestricted use, distribution, and reproduction in any medium, provided you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons license, and indicate if changes were made. The Creative Commons Public Domain Dedication waiver (http://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Singh, R., Dillon, JA.R., Demczuk, W. et al. Gen2Epi: an automated whole-genome sequencing pipeline for linking full genomes to antimicrobial susceptibility and molecular epidemiological data in Neisseria gonorrhoeae. BMC Genomics 20, 165 (2019). https://doi.org/10.1186/s12864-019-5542-3

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s12864-019-5542-3

Keywords