Abstract
Expert curated annotation remains one of the critical steps in achieving a reliable biological relevant annotation. Here we announce the release of GAMOLA2, a user friendly and comprehensive software package to process, annotate and curate draft and complete bacterial, archaeal, and viral genomes. GAMOLA2 represents a wrapping tool to combine gene model determination, functional Blast, COG, Pfam, and TIGRfam analyses with structural predictions including detection of tRNAs, rRNA genes, non-coding RNAs, signal protein cleavage sites, transmembrane helices, CRISPR repeats and vector sequence contaminations. GAMOLA2 has already been validated in a wide range of bacterial and archaeal genomes, and its modular concept allows easy addition of further functionality in future releases. A modified and adapted version of the Artemis Genome Viewer (Sanger Institute) has been developed to leverage the additional features and underlying information provided by the GAMOLA2 analysis, and is part of the software distribution. In addition to genome annotations, GAMOLA2 features, among others, supplemental modules that assist in the creation of custom Blast databases, annotation transfers between genome versions, and the preparation of Genbank files for submission via the NCBI Sequin tool. GAMOLA2 is intended to be run under a Linux environment, whereas the subsequent visualization and manual curation in Artemis is mobile and platform independent. The development of GAMOLA2 is ongoing and community driven. New functionality can easily be added upon user requests, ensuring that GAMOLA2 provides information relevant to microbiologists. The software is available free of charge for academic use.
Keywords: genome annotation, microbial, sequence analysis, stand-alone software, genome visualization, expert curation, Artemis genome viewer
Introduction
The advent and continued rise of Next Generation DNA sequencing has enabled microbiologists to investigate more and more microbes on a genome level. Recent deep sequencing projects have generated metagenomic datasets that reach sufficient coverage to assemble genes, operons and—in some cases—larger contigs and draft genomes (Ross et al., 2016; Sangwan et al., 2016), granting insights into the non-culturable biosphere. One of the primary objectives in the subsequent data analyses is the identification of genes and, where possible, the prediction of their respective biological functions.
In 2003 the prokaryotic genome annotation pipeline GAMOLA (Altermann and Klaenhammer, 2003) was developed with the aim of providing microbiologists with a user friendly system for effective and reliable (draft) genome annotation. The fully localized annotation pipeline enabled the analysis of confidential or otherwise sensitive sequences without the need for remote data access or otherwise transmitting sequences. Since then, a number of other genome annotation systems have been established—ranging widely in scope, functionality and data analysis philosophies. Perhaps the most well-known and elaborate remote data processing system is the Integrated Microbial Genomes (IMG) system developed and hosted by the Joint Genome Institute and the Lawrence Berkeley National Laboratory (Markowitz et al., 2009, 2014, 2015). Other systems provide more specialized services, such as gene syntax analysis (Cruveiller et al., 2005), identifying possible problems in annotated genomes through genomics (Poptsova and Gogarten, 2010), comparative analyses of microbial genomes (Altermann, 2012; Overmars et al., 2013) or suggesting rules and standards for (meta-)genome annotations (Angiuoli et al., 2008). A smaller number of pipelines (e.g., AGeS, MyPro, MEGAnnotator, IGS annotation engine, GIT genomics pipeline, RASTtk, Ergatis, and Prokka) is dedicated to providing the means to analyse microbial genomes using local resources in the same way the original GAMOLA software did (Kislyuk et al., 2010; Galens et al., 2011; Kumar et al., 2011; Seemann, 2014; Brettin et al., 2015; Liao et al., 2015; Lugli et al., 2016).
Here we present the second major release of the localized microbial genome annotation pipeline GAMOLA2. The new release represents a complete re-write of the original command line code and introduces a flexible graphical user interface and a modular concept that facilitates the continuous addition of new tools as requested by the user base. The project was initiated in 2007. New functionalities were added and the output format was refined based on continuous user feedback.
While GAMOLA2 requires a Linux based system to generate the comprehensive genome annotation, the use of a customized version of the Artemis Java application (Rutherford et al., 2000) ensures platform independence for subsequent expert curation and analyses. GAMOLA2 has been tested and validated on a wide range of draft and completed bacterial and archaeal genomes (Ventura et al., 2006; Attwood et al., 2008; Azcarate-Peril et al., 2008; Hagen et al., 2010; Leahy et al., 2010, 2013; Lu et al., 2010; Nelson et al., 2010; Altermann and Klaenhammer, 2011; Cookson et al., 2011; Goh et al., 2011; Yeoman et al., 2011; Altermann, 2012; Crespo et al., 2012; Sturino et al., 2013, 2014; Kelly et al., 2014; Lambie et al., 2014, 2015; Cavanagh et al., 2015). In addition to the core genome annotation functionality, several modules have been implemented to aid in managing and publishing microbial genomes.
The GAMOLA2/Artemis software package is available free of charge for academic use.
Description
Objective
GAMOLA2 was developed to provide a comprehensive and relevant automated annotation of draft and completed microbial genomes for microbiologists by assembling a wide array of different analyses. The annotation that is provided should fulfill criteria that represent a consensus of many microbiological teams and users. The most important criteria were that the annotation should provide biological background information wherever possible, be easily accessible and visually congruent, and access to the annotation data must be fast, mobile and as platform independent as possible. Further requests included the facility to deal with confidential/sensitive sequences, track changing draft sequences and the ability to access the full range of results obtained for each predicted gene.
To realize these standards, GAMOLA2 was developed with the aim to provide a completely localized microbial annotation platform that can be executed on small to medium sized computing resources without the need for underlying dependencies such as database systems or web-interfaces. The primary output of GAMOLA2 is a comprehensively annotated Genbank file, supported by a range of text-based data files. A customized version of the Artemis genome viewer (version 16) (Rutherford et al., 2000) has been developed to take advantage of the additional features GAMOLA2 provides and is part of the software distribution.
GAMOLA2 attempts to anticipate the most common user mistakes observed over time and will internally correct them wherever possible or inform the user before proceeding with the analysis. A log file with all errors encountered during the analysis is maintained and can be accessed for detailed troubleshooting.
Framework
GAMOLA2 primarily represents a wrapper to bring together a wide range of specialized individual software tools. This core functionality is then enhanced by a number of custom routines (such as the intergenic Blast analysis). The pipeline is written entirely in Perl and Perl::Tk and has been developed with the ActivePerl 5.8.8.822 distribution and on CentOS release 6.7, using Xming on a Windows host. Has been further tested a Fedora release 21 virtual box on a Windows host and on an Apple PC running XQuartz connected to a CentOS server. The ActivePerl distribution is included as RPM package and tarball and must be installed if not already present. GAMOLA2 is fully multithreaded and can utilize multiple CPUs and cores to reduce runtimes significantly. Other minor dependencies (i.e., presence of “unrar” and the Java runtime environment) are described in more detail in the GAMOLA2 manual.
Installing software can sometimes be a difficult process, requiring the acquisition of numerous dependencies. The GAMOLA2 distribution comes with all software tools and specialized databases provided (with the exceptions of TMHMM Krogh et al., 2001, and SignalP Dyrlov Bendtsen et al., 2004; Petersen et al., 2011, that must be obtained separately) and, once ActivePerl is available on the system, will perform an automatic installation and compilation of all required tools, folder structures, databases and default thresholds when run for the first time. On subsequent runs, GAMOLA2 will test if all resources required are present before each annotation start and, when necessary, recompile missing tools automatically. Only large databases—such as the non-redundant NCBI databases must be downloaded separately, due to their increasing size. A complete list of software tools used and their respective links can be found in the software manual.
A typical annotation run creates up to 3.5 Gb of data for a 4.5 Mbp genome with ~7,000 predicted genes. Using 30 cores and the NCBI non-redundant Blast database, the annotation run took ~4 days to complete. Selecting a more targeted Blast database (e.g., SwissProt or NCBI RefSeqs) will reduce runtimes considerably. The actual amount of data generated varies based on the size of the predicted gene model and analyses selected. The entire annotation can be compressed into a single archive to simplify its distribution across multiple systems and users.
Input
GAMOLA2 recognizes FASTA and Genbank files as input formats. Both FASTA and Genbank files may contain multiple entries (msFASTA and msGenbank) and can be combined within an annotation run.
The annotation pipeline is explicitly designed to process draft genomes: individual contigs, input files and combinations thereof can either be treated as separate entities or concatenated using a non-bleeding spacer sequence that prevents genes from bleeding across contig boundaries.
Genbank files that harbor a gene model comprising of “gene” and “CDS” features may either be updated or re-created. It is also possible to combine selected input files into groups that are subsequently concatenated.
In addition, external gene models may be provided to force a specific genome annotation.
Workflow
The increased number of options and parameters offered in the annotation pipeline made the use of a simple command line interface too cumbersome for efficient use. GAMOLA2 therefore now features a graphical user interface (GUI) than leads logically from an initial system parameter setup, to selecting functional and structural analyses, to database selection and input file organization. Once the runtime parameters have been set, the entire configuration can be saved and may be re-used at the next annotation run. Alternatively, default settings can be loaded to restore the original configuration. A general overview of the core options and workflow for GAMOLA is shown in Figure 1.
The following provides a general overview of the GAMOLA2 pipeline and its main options. For more detailed information on individual options, refer to the software manual [provided in the distribution and as a Supplemental File (Supplemental Presentation 1)].
Systems setup
Upon invoking GAMOLA2, the system setup offers a number of options to adapt the behavior of the pipeline to the respective system it runs on and the specific annotation outputs. When continuing from a previous or an interrupted run, existing results may be re-used to reduce run-time. Where results are being re-used, existing data files are tested individually for integrity and, when found to be corrupted, are removed and run again. The final annotation may be consolidated by creating a gene model with sequential gapless gene numbers. For convenient transfer the entire output can be archived into a single file (Supplemental Figure 1). Other system options allow users to filter Blast results, providing the option to ignore Blast hits that match specific key words for the annotation (Supplemental Figure 2). Where Genbank files are used as input files, GAMOLA2 can either create a new Genbank file, erasing existing data, or instead update selected analyses (Supplemental Figure 3). Updating existing Genbank files allows all genes to be re-examined against updated or other custom databases, using the embedded gene model. Only selected analyses will be updated, while retaining all other existing features. Existing “gene” and “CDS” annotations can be maintained if manual curation has already been carried out, preventing the loss of expert annotations throughout different rounds of analyses. Default and custom Genbank headers for input files can be built using a point-and-click system and respective field values be pre-configured and saved (Supplemental Figures 4A–C).
Main options
The core functionality of microbial genome annotation comprises the determination of a gene model and subsequent analyses of the deduced gene against a selection of databases that provide insights into possible biological function (Supplemental Figure 5A).
GAMOLA2 accepts external gene models in general feature format (GFF) and an internal format in cases where a specific gene model is desired. Genbank input files with an embedded feature list may be updated while preserving the existing gene model. In all other cases, a new gene model is created. Presently, GAMOLA2 supports four different gene callers (Glimmer2 (Delcher et al., 1999) or Glimmer3 (Delcher et al., 2007), Prodigal (Hyatt et al., 2010) and Critica (Badger and Olsen, 1999; Supplemental Figure 5B). In addition, an intergenic Blast can be carried out to identify potential frame shifts, premature stop codons or, in case of fragmented draft genomes, incomplete open reading frames (ORFs) located at contig boundaries (Supplemental Figure 5C). The intergenic Blast is highly customisable and allows users to specify the minimum intergenic ORF (igORF) length and how far a potential intergenic region may reach into existing adjacent genes. Potential ORFs can be determined either via an orientation-aware algorithm (a separate igORF search in sense and antisense orientation, respectively) or by flattening the gene model (igORFs are considered for intergenic regions between all genes). Identified candidate ORFs are then subjected to a BlastP analysis against either standard or custom databases and those with hits below a chosen e-value threshold are added to the gene model. When multiple gene calling algorithms are combined in one annotation run, an additive gene model will be formed, featuring the highest number of the largest potential genes. While this approach increases the potential for false positives, we found that it is more beneficial and faster to remove individual genes or features during expert curation in Artemis than manually investigating regions with potential missed genes.
Once the gene model has been created, genes can be analyzed against Blast (e.g., NCBI nr/nt, NCBI RefSeqs, SwissProt, or other custom Blast databases), COG, PFam, and TIGRfam functional databases. For Pfam and TIGRfam analyses, several levels of verbosity can be selected to include detailed domain descriptions as well as additional Interpro (Pfam) and GeneOntology (TIGRfam) information. Often TIGRfams feature distinct gene names and GAMOLA2 offers an option to preferentially create gene annotations from TIGRfam gene designations for the automated annotation.
In some cases, legacy versions of specific tool may be desired and GAMOLA2 supports legacy Blast, and hmmer2 alongside the recent Blast plus and hmmer3 distributions.
Supplemental structural analyses
Aside from the core functional databases, structural features—both within a gene and located in intergenic regions-can provide valuable information on gene context and protein function. Where applicable, analyses can be adapted to specific genome requirements by changing the default parameters.
Transfer RNAs (tRNA) are determined using tRNAscan-SE (Lowe and Eddy, 1997), while non-coding RNAs (ncRNA) are detected using Infernal (Griffiths-Jones et al., 2003). Ribosomal RNAs (rRNA) can either be predicted via Infernal or deduced by a custom build database (provided with the distribution). In the latter case, Blast alignments are analyzed and full length rRNA genes extrapolated based on respective alignment positions (Supplemental Figure 6A).
The location of proteins within a cell can be of importance and may give first clues in cases of conserved hypothetical genes. The prediction of transmembrane helices (Krogh et al., 2001) and signal peptide cleavage sides (Petersen et al., 2011) has been incorporated into GAMOLA2. The transmembrane helix analysis may further be configured to display the position and length of individual helices within a gene (Supplemental Figure 6B).
Other DNA structures such as rho-independent terminators (Kingsford et al., 2007) or CRISPR repeats (Bland et al., 2007) may provide additional information on potential operon structures and genome plasticity, respectively (Supplemental Figure 6C).
Vector contamination may occur, particularly in draft genomes and metagenomes when filter steps had to be avoided. GAMOLA2 can detect such contaminations by screening sequences against the UniVec or UniVec_core databases (http://www.ncbi.nlm.nih.gov/tools/vecscreen/univec/, Supplemental Figure 6D).
A current known limitation of GAMOLA2 is the absence of microbial promoter prediction.
Databases
Most functional and some structural analyses require dedicated databases. For Blast, both standard public databases (such as the non-redundant Blast database maintained by the National Center for Biotechnology Information (NCBI)) as well as custom Blast databases (see below) can be used. Depending on the selected Blast flavor, GAMOLA2 will test if the correct type of Blast database has been chosen and prompt the user in cases of incompatible selections.
Clusters of Orthologous Groups of proteins (COGs) are widely used to provide a high level classification of genes or to summarize the genome. GAMOLA2 supports six different COG databases that are provided with the distribution: COG 2003 (Tatusov et al., 2003), 2008 and 2014 (Galperin et al., 2015), archaeal COGs 2007 (Makarova et al., 2007) and 2014 (Makarova et al., 2015), and the 2013 phage COGs (Kristensen et al., 2013). Where possible, individual COG codes are translated into human readable descriptors during the annotation process and are employed both in the annotated Genbank file(s) as well as in individual COG result files.
By default, the standard Pfam and TIGRfam databases are used for analysis. In some cases, multiple databases may be chosen (e.g., Pfam-A and Pfam-B) for the annotation. If multiple PFam or TIGRfam databases were selected, GAMOLA2 investigates the first selected database (e.g., Pfam-A) and, if at least one hit below the selected threshold was found, moves on to the next gene without analysing subsequent selected databases (e.g., ignores PFam-B). Additional databases are analyzed in the order selected (e.g., Pfam-B), only in cases where no significant hits in the previous database (e.g., Pfam-A) were detected (Supplemental Figure 7).
Configuring input sequences and starting the annotation
The annotation of draft and complete genomes and other genetic elements often requires a flexible approach on how input files and embedded entries are processed. Draft genomes may consist of many individual contigs, sometimes across multiple data files, whereas multiple completed genomes are to be analyzed as separate entities within a single annotation run. GAMOLA2 provides a high level of flexibility in the way input files can be combined or disassembled (Supplemental Figure 8).
Draft phase genomes may consist of hundreds of individual contigs and assembled metagenomes often comprise thousands of small sequence fragments. While annotating each contig or fragment individually is possible with GAMOLA2, a more common approach is to concatenate entries in the order given by the input files using a defined spacer sequence that is easily identifiable and prevents ORF-bleeding across contig boundaries by introducing stop codons across all six reading frames (5′-NNNNNNNNNNTTAGTTAGTTAGNNNNNNNNNN-3′). This concatenation can be carried out for both FASTA and Genbank input files, whereby existing gene models for multiple Genbank files are discarded and a new gene model built. Similarly, the presence of “N”s in the nucleotide sequence may represent known gaps and GAMOLA2 can be set to replace those “N”s with the non-bleeding spacer sequence, albeit without breaking the contig. This approach ensures that predicted genes are not allowed to span these undefined regions, increasing the reliability of the gene model.
Finally, multiple input files may be combined into annotation groups that are concatenated into a single entity. This option allows the easy combination of fragmented draft genomes distributed across multiple input files or the merger of multiple replicons of a microbe.
Automated annotation
Once all selected analyses have been carried out, GAMOLA attempts to provide an automated annotation for each predicted gene. Automated annotations are generated based on Blast and TIGRfam results. If neither Blast nor TIGRfam is selected in an annotation run, each gene will be annotated as “unknown.” If Blast is selected, gene annotations will be based on the best Blast hit that features an e-value below the user defined threshold. If only Blast hits above the threshold were detected, the gene will be annotated as “conserved hypothetical.” If no Blast hits were found, gene annotation will be set to “unknown.” TIGRfam hits often have well curated gene names and descriptors. If selected, the best TIGRfam hit below the selected e-value threshold will be chosen to override the Blast-based automated annotation for both “gene” and “CDS” features. When selected, E.C. numbers will be added to the “CDS” feature.
GAMOLA2 output files
Once the GAMOLA2 annotation run has finished, several outputs will be available:
Results for all input files are saved in the “Results” directory and are accessible in individual, analysis-specific directories. These are considered the original data, based on the gene model created.
GAMOLA2 offers the option to sort individual input files and save respective input-specific results into separate folders (Figure 2). A separate directory is created for each annotation entity which harbors all information created for that annotation. Individual data for each gene are saved in respective analysis-type folders (e.g., Blast_database, COG_database, etc). A FASTA file of the (concatenated) nucleotide sequence and a text file with the contig order (providing contig names and respective start and stop positions) are accompanying files to the annotated Genbank file. The Genbank file harbors all features selected in the GAMOLA2 annotation run. Genes are represented as both a gene and CDS feature for annotation purposes. Further, they are given a unique and sequential gene number that is used to retrieve underlying raw data in Artemis (see below).
When selected, GAMOLA2 compresses all results into two archive files: – “object_results” contains the raw unsorted data that can be used to re-populate result folders in case analyses need to be re-run, which will reduce runtime. – “consolidated_results” holds the separated and sorted result files for each entity used in the annotation run. This is the archive that will be used for further analyses and curation in Artemis.
An error log file is created for each annotation run and saved in the home directory. In this file are listed all errors that were encountered during the annotation process. It provides many pointers to problems within the gene model and often proves useful in identifying problems in the input sequences.
Genome visualization and curation in the modified artemis genome browser
Working with microbial genomes should be fast, flexible, and intuitive. Often, genes are investigated in their wider context and distant loci are frequently targeted when carrying out functional analyses. The Artemis Genome Browser (Rutherford et al., 2000) has been under continuous development since 2000 and still represents one of the best and most flexible genome browsers designed to date. Artemis is a Java-based application and therefore platform independent with no further dependencies required, making it the ideal companion for the GAMOLA2 annotation. We have created a modified version of Artemis with added functionality to take advantage of the GAMOLA2 annotation output. In particular, additional feature keys have been incorporated and given defined color values that create a coherent visual layout for each gene (Figure 3, shaded boxes). Each gene consists of a “gene” and a “CDS” feature with the same start-stop positions, enabling researchers to specify both a short gene name and a more biologically-interpretable description of the prediction function (Supplemental Figure 9A, highlighted qualifier). Within the gene boundaries, functional and structural hits are shown in their assigned color codes, displaying relevant information (e.g., biological roles, e-values, alignment lengths and scores) of the respective best hits found. The next gene starts again with the “gene” and “CDS” features. Using this system, it is straightforward to perceive common biological themes across all hits for a given gene and verify or correct the automatic annotation. Where further information is required on the role or composition of individual features, relevant information embedded in the Genbank file can be retrieved directly from within Artemis (Supplemental Figure 9B). A second modification in Artemis provides direct access to underlying Blast, COG, PFam, and TIGRfam results. By selecting a “gene” or “CDS” feature, all or individual analysis results can be retrieved, enabling a more comprehensive insight in biological roles and the presence of homologs (Figure 3 and Supplemental Figure 9C). In particular for poorly characterized genes, investigating functional hits above the selected threshold across all databases may reveal common biological “themes” enabling at least a putative annotation. Where concatenated sequences are present, individual contigs are marked by features in alternating colors, emphasizing contig boundaries to prevent erroneous assumptions on gene synteny across contigs.
The GAMOLA2-Artemis software package enables individual researchers to routinely curate 200 to 250 genes per day. An annotation guideline that suggests an optimized annotation workflow has been added to the user manual and can be easily adapted to respective team requirements.
Supplemental modules
Microbial genome annotation requires a number of flexible tools to implement specialized analyses and data interpretation. GAMOLA2 offers a range of supplemental modules that extend its functionality beyond that of a pure annotation pipeline. These modules have been developed for GAMOLA2 based on user feedback and real-world requirements regularly experienced, and are given here.
Creating custom blast databases
Creating custom Blast databases is required where specific data analysis is required, e.g., comparing a query microbial genome against other known genomes of the same strain/species. GAMOLA2 provides such a module, creating nucleotide and amino-acid Blast databases from (ms)Genbank to (ms)FASTA files. These databases can be rapidly built and then used in subsequent annotation runs (Supplemental Figure 10). To ensure that custom Blast databases are of high integrity, GAMOLA2 tests input files for errors and inconsistencies during the parsing process.
Rotating genbank files
Assembled sequences often present a random genome location as starting points. By convention, complete genomes often begin at agreed anchor points, such as origins of DNA replication (e.g., the chromosomal replication initiator protein DnaA) and genomes are routinely re-oriented before submission into sequence depositories. GAMOLA2 features the ability to rotate annotated Genbank files to new starting points, shifting all features accordingly while retaining the original gene numbers (Supplemental Figure 11). When preparing such a rotated Genbank file for submission via Sequin (see below), respective locus tags may then be reset to start with “0001.”
Preparing genbank files for submission
Submitting extensively annotated Genbank files is often a time intensive process. One of the most commonly used tools for submission to NCBI is Sequin (http://www.ncbi.nlm.nih.gov/Sequin/) which accepts both manual entry of features as well as a batch submission using a tabulated input file. The genome submission preparation module of GAMOLA2 was developed to minimize the time required to submit a genome to NCBI using Sequin (Supplemental Figure 12). The module supports the preparation of both complete and draft phase genomes and can generate AGP scaffold information data for the latter (https://www.ncbi.nlm.nih.gov/assembly/agp/AGP_Specification/). Where a submission is comprised of multiple entities (e.g., a multi-replicon genome architecture), these can be either linked via locus tags or be treated as individual sequences. While a wide range of features can be selected to be incorporated into the submission, a minimum set consisting of “gene,” “CDS,” and “rRNA” features is recommended. CDS features may be further customized to include specific supplemental qualifiers. The output of this module consists of a FASTA file, the Sequin feature table and, where applicable, the AGP information file.
Annotation transfer between genomes
Working with early and advanced draft phase genomes poses the problem of ongoing changes in the assemblies and, consequently, in generated gene models. Expert curation will often start with early draft phase genomes and continue until the genome is closed and validated. The problem, however, is that due to changes in the assembly, curated annotations may not be directly transferrable between assembly versions. GAMOLA2 addresses this problem by enabling a transfer of gene annotations between different assembly versions (Supplemental Figure 13). Both “gene” and “CDS” annotation can be transferred. As a first approach, genes with identical sequences will be captured and annotation transferred. Similarly, genes that have been extended or truncated, will be identified in a second pass. Finally, where amino acid sequences have changed between draft versions, a Blast search is carried out to determine the best fit. The sensitivity of the Blast analysis can be adjusted by changing the minimum percent identify threshold required for the alignment. Ambiguous matches (e.g., multiple gene copies as found for integrases) or no matches between genome versions for a given gene will be recorded in a separate log file and can be validated manually.
Custom metagenome analysis
One of the advantages of the new modular structure of GAMOLA2 is the ability to rapidly develop and implement new analyses and customized modules. One such example is the examination of metagenome reads against custom Blast databases with the aim of obtaining a comparative high-level overview of the distribution and levels of similarity against specific protein/enzyme families (Supplemental Figure 14). The purpose of the module is not to provide a detailed and comprehensive analysis of a given metagenomic dataset, but to enable an assessment of the frequency and respective levels of similarity of individual metagenomic reads against a thematic (i.e., a custom Blast database comprising entries of a similar function) Blast database. A known limitation of this type of analysis lies within the Blast algorithm and the calculation of the e-value with respect to database size and query length. Custom Blast databases of very different sizes may impact the e-value while read lengths may vary within a dataset and between different sequencing platforms. Care should be taken when comparing results and read lengths should be filtered for length were possible. Further, input data should be adjusted and have undergone a quality control step before being analyzed.
The module was designed to investigate metagenomic reads in FASTA format (based on the 454-FLX sequencing platform) that are blasted (BlastN, BlastX, or tBlastN) against standard or custom Blast databases. Identical reads may be collapsed (only one representative read will be submitted to Blast, reducing the overall number of queries) and their respective frequencies is reported. An upper e-value threshold can be set to define a minimum level of similarity to subject hits. The analysis provides a number of output files, including the original Blast output, two tab-delimited summary files that provide information on hit frequencies for two respective Blast e-values ranges, and a detailed results overview that can be imported into Excel for detailed data mining. The provided data can be used to create comparative graphical representations between one or more metagenomes and respective custom databases (Supplemental Figure 15). A metagenomic analysis using a custom Blast database comprising 69,869 entries, with a query metagenome (source: IMG genome ID: 3300000524 or NCBI BioProject database: PRJNA244109: 609,709 unassembled nucleotide reads, Ciric et al., 2014) took 70 min utilizing 60 cores on a CentOS server. A comparison between results for specific enzyme classes between IMG/M and GAMOLA2 is shown in Supplemental Table 1. For a chosen e-value threshold of 1e-50 GAMOLA2 results were in general agreement with IMG/M data for most enzyme classes. Differences in results (e.g., for arabinosidases) may result from the underlying Blast database makeup.
Comparison to other annotation systems
A number of other annotation system have been published over the last decade and perhaps most notable for local microbial annotations are Prokka (Seemann, 2014), ConsPred (Weinmaier et al., 2016), and RAST/myRAST (Aziz et al., 2008). A comparison between all four platforms (Table 1) revealed that each system offers different features that are indicative of respective purposes and philosophies.
Table 1.
GAMOLA2 | PROKKA | ConsPred | RAST/myRAST | |
---|---|---|---|---|
RUNTIME ENVIRONMENT | ||||
GUI | ||||
Visualization of annotation | (a) | (b) | (c) | |
Local PC | ||||
Server-client/terminal | ||||
Cloud | ||||
Web-based | ||||
Multi-threaded | ||||
Off-line capability | ||||
Re-use previous results | ||||
Filter Blast results | (d) | (e) | ||
GENE MODEL PREDICTION | ||||
Glimmer 2/3 | ||||
Prodigal | (f) | |||
Critica | ||||
GeneMark | ||||
RAST | ||||
Intergenic Blast | ||||
Blast Homology based gene prediction | ||||
RBS | ||||
External gene model | (g) | |||
Additive prediction | ||||
Rule based prediction | ||||
FUNCTIONAL ANALYSES | ||||
Blast/Blast-Plus | ||||
Multiple Blast flavors | (h) | (h) | ||
Custom Blast databases | (i) | |||
COG | ||||
Multiple COG databases | (j) | |||
eggnog | (k) | |||
Pfam (HMMER2/3) | ||||
TIGRfam | ||||
FIGfam | ||||
Selection of multiple databases | (l) | |||
Gene Ontology descriptor | ||||
InterPro descriptor | ||||
InterProScan | ||||
EC number | ||||
KEGG | ||||
Metabolic reconstruction | ||||
STRUCTURAL ANALYSES | ||||
tRNA | ||||
rRNA | ||||
Non-coding RNAs | ||||
Transmembrane helices | ||||
Signal Peptide Cleavage Sites | ||||
Rho-independent terminators | ||||
CRISPRs | ||||
Vector screen | ||||
INPUT FORMATS AND SEQUENCE HANDLING | ||||
FASTA | ||||
msFASTA | ||||
Genbank | ||||
msGenbank | ||||
Concatenate sequences | ||||
Create concatenated sequence clusters | ||||
Prevent gene model bleeding across contigs | ||||
Update Genbank files | ||||
OUTPUT | ||||
Genbank | (m) | |||
GFF tracks | ||||
EMBL | ||||
All features displayed | ||||
Embedded feature descriptors | ||||
Feature csv/tsv file | (n) | |||
Feature Excel file | (n) | |||
Log and Error files | (o) | |||
Statistic file | (n) | |||
OTHER FEATURES | ||||
Create custom Blast databases | ||||
Rotate Genbank files | ||||
Prepare for Sequin submission | ||||
Annotation transfer | ||||
Functional Metagenome analysis |
Via enhanced Artemis genome viewer;
static HTML sites to KEGG and KO;
custom browser;
custom filter;
automatic;
default;
internal and GFF format;
blastp only;
NCBI nr only;
COG2003, COG2008, COG2014, arCOG, arCOG2014, POG2013;
planned in next release;
for Pfam and TIGRfam;
partial feature only;
available as separate software, integration in the next release update;
Gamola2 creates verbose error logs.
For example, Prokka delivers extremely fast annotation results, even on a typical desktop computer. Prokka achieves this fast turnaround by focusing on curated databases (e.g., UniProt, Pfam and TIGRfam) and by limiting custom databases to finished bacterial genomes of the same genus. In contrast, GAMOLA2 follows the opposite philosophy by providing as much verbose information for each predicted gene as possible. Rather than implying a given gene annotation, GAMOLA2 aims at creating a comprehensive dataset that enables rapid and confident expert curation.
ConsPred features a novel rule-based algorithm to predict the most accurate gene model, while GAMOLA2 builds an additive gene model that may also include partial genes to provide the most inclusive gene model—acknowledging the inclusion of false positives in the gene model that will then be removed during expert curation. In particular for fragmented draft phase genomes, it is easier and faster to delete false positives from the gene model than to detect, analyse, and add missing genes.
Similarly, RAST/myRAST focus on metabolic network reconstruction and is built on a unique datasets (e.g., FIGfam) and cross-platform access (e.g., SEED database) that highlights biochemical pathways present within bacterial genomes.
Each of these platforms provides a different focus for microbial genome annotations. Which system will ultimately be most suited for a given genome project will depend on the respective requirements at and purpose of the resulting annotation.
Summary
The GAMOLA2/Artemis ecosystem provides a comprehensive, user-friendly and readily accessible framework for microbiologists to work with and curate draft and completed genomes. Specific emphasis was given to providing functional and structural analyses in a stand-alone environment that does not require remote access or rely on other underlying dependencies (other than the ActivePerl distribution and Java). GAMOLA2 utilizes recognized tools with known performance parameters that are combined into a single source of information. The main output comprises an annotated Genbank file with additional features and descriptive qualifiers that, in combination with the Artemis Genome viewer, create an intuitive and responsive environment to rapidly assess individual database hits for each gene in their totality and create expert curations. The supplemental modules in GAMOLA2 further increase the flexibility for genome annotations and provide assistance for tracking draft phase genomes, and the submission of genomes to depositories.
GAMOLA2 is continuously being developed and new functionality and additional supplemental modules will be integrated based on user-feedback.
Availability
The GAMOLA2/Artemis distribution is freely available for academic use and can be downloaded from Google Drive (Table 2 lists to respective URLs to download all GAMOLA2 components). The distribution already contains most software tools and some specialized databases. Larger databases and those that are frequently updated require a separate download and can either be downloaded via a snapshot file (Table 2) or manually by following the instructions in the manual. The provided snapshot database file will be updated periodically alongside the GAMOLA2 distribution.
Table 2.
GAMOLA2 software distribution | Download link | File size [KB] |
---|---|---|
Readme | https://drive.google.com/file/d/0B_fIEHIR2oaacWQ1T0Y2dm0wWUk/view?usp=sharing | 1 |
GAMOLA2 Manual (PDF) | https://drive.google.com/file/d/0B_fIEHIR2oaaczBQT2dYQUw4TUE/view?usp=sharing | 3,947 |
GAMOLA2 distribution | https://drive.google.com/file/d/0B_fIEHIR2oaabVlzcF9NUTlnbjQ/view?usp=sharing | 1,376,676 |
Customized Artemis 16 | https://drive.google.com/file/d/0B_fIEHIR2oaaM1RndXVpZUl4emc/view?usp=sharing | 24,116 |
GAMOLA2 tutorial dataset | https://drive.google.com/file/d/0B_fIEHIR2oaadVpVZEZuSUZBYkU/view?usp=sharing | 5,265 |
Databases | https://drive.google.com/file/d/0B_fIEHIR2oaaVHlRZmc0cWJBOTA/view?usp=sharing | 1,201,277 |
An example annotation is provided with the distribution package and can be used for training purposes in Artemis.
Author contributions
EA wrote the GAMOLA2 software, the manual and the manuscript. EA, JL, and AM designed the Artemis modifications. JL programmed the modified version of Artemis. JL and AM reviewed the manual and the manuscript.
Conflict of interest statement
The authors declare that the research was conducted in the absence of any commercial or financial relationships that could be construed as a potential conflict of interest.
Acknowledgments
The authors thank Dr Christina Moon for access to the metagenome and permission to use the data for this manuscript. We also thank the AgResearch Data Center in Invermay (NZ), Russel Smithies, and Simon Guest for access to the high performance server, dedicating resources and providing conceptual advice.
Supplementary material
The Supplementary Material for this article can be found online at: http://journal.frontiersin.org/article/10.3389/fmicb.2017.00346/full#supplementary-material
References
- Altermann E. (2012). Tracing lifestyle adaptation in prokaryotic genomes. Front. Microbiol. 3:48. 10.3389/fmicb.2012.00048 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Altermann E., Klaenhammer T. (2011). Group-specific comparison of four lactobacilli isolated from human sources using differential blast analysis. Genes Nutr. 6, 319–340. 10.1007/s12263-010-0191-9 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Altermann E., Klaenhammer T. R. (2003). GAMOLA: a new local solution for sequence annotation and analyzing draft and finished prokaryotic genomes. Omics 7, 161–169. 10.1089/153623103322246557 [DOI] [PubMed] [Google Scholar]
- Angiuoli S. V., Gussman A., Klimke W., Cochrane G., Field D., Garrity G. M., et al. (2008). Toward an Online Repository of Standard Operating Procedures (SOPs) for (Meta) genomic Annotation. OMICS 12, 137–141. 10.1089/omi.2008.0017 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Attwood G. T., Kelly W. J., Altermann E. H., Leahy S. C. (2008). Analysis of the Methanobrevibacter ruminantium draft genome: understanding methanogen biology to inhibit their action in the rumen. Aust. J. Exp. Agric. 48, 83–88. 10.1071/EA07269 [DOI] [Google Scholar]
- Azcarate-Peril M. A., Altermann E., Goh Y. J., Tallon R., Sanozky-Dawes R. B., Pfeiler E. A., et al. (2008). Analysis of the genome sequence of Lactobacillus gasseri ATCC 33323 reveals the molecular basis of an autochthonous intestinal organism. Appl. Environ. Microbiol. 74, 4610–4625. 10.1128/AEM.00054-08 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Aziz R. K., Bartels D., Best A. A., DeJongh M., Disz T., Edwards R. A., et al. (2008). The RAST Server: Rapid Annotations using Subsystems Technology. BMC Genomics 9:75. 10.1186/1471-2164-9-75 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Badger J. H., Olsen G. J. (1999). CRITICA: coding region identification tool invoking comparative analysis. Mol. Biol. Evol. 16, 512–524. 10.1093/oxfordjournals.molbev.a026133 [DOI] [PubMed] [Google Scholar]
- Bland C., Ramsey T. L., Sabree F., Lowe M., Brown K., Kyrpides N. C., et al. (2007). CRISPR recognition tool (CRT): a tool for automatic detection of clustered regularly interspaced palindromic repeats. BMC Bioinformatics 8:209. 10.1186/1471-2105-8-209 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Brettin T., Davis J. J., Disz T., Edwards R. A., Gerdes S., Olsen G. J., et al. (2015). RASTtk: a modular and extensible implementation of the RAST algorithm for building custom annotation pipelines and annotating batches of genomes. Sci. Rep. 5:8365. 10.1038/srep08365 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Cavanagh D., Casey A., Altermann E., Cotter P. D., Fitzgerald G. F., McAuliffe O. (2015). Evaluation of non-dairy Lactococcus lactis with potential dairy applications reveals extensive phenotype-genotype disparity: implications for a revised species. Appl. Environ. Microbiol. 81, 3961–3972. 10.1128/AEM.04092-14 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Ciric M., Moon C. D., Leahy S. C., Creevey C. J., Altermann E., Attwood G. T., et al. (2014). Metasecretome-selective phage display approach for mining the functional potential of a rumen microbial community. BMC Genomics 15:356. 10.1186/1471-2164-15-356 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Cookson A. L., Noel S., Hussein H., Perry R., Sang C., Moon C. D., et al. (2011). Transposition of Tn916 in the four replicons of the Butyrivibrio proteoclasticus B316(T) genome. FEMS Microbiol. Lett. 316, 144–151. 10.1111/j.1574-6968.2010.02204.x [DOI] [PubMed] [Google Scholar]
- Crespo M. D., Olson J. W., Altermann E., Siletzky R. M., Kathariou S. (2012). Chromosomal tet(O)-harboring regions in campylobacter coli isolates from Turkeys and Swine. Appl. Environ. Microbiol. 78, 8488–8491. 10.1128/AEM.02258-12 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Cruveiller S., Le Saux J., Vallenet D., Lajus A., Bocs S., Médigue C. (2005). MICheck: a web tool for fast checking of syntactic annotations of bacterial genomes. Nucleic Acids Res. 33, W471–W479. 10.1093/nar/gki498 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Delcher A. L., Bratke K. A., Powers E. C., Salzberg S. L. (2007). Identifying bacterial genes and endosymbiont DNA with Glimmer. Bioinformatics 23, 673–679. 10.1093/bioinformatics/btm009 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Delcher A. L., Harmon D., Kasif S., White O., Salzberg S. L. (1999). Improved microbial gene identification with GLIMMER. Nucleic Acids Res. 27, 4636–4641. 10.1093/nar/27.23.4636 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Dyrlov Bendtsen J., Nielsen H., von Heijne G., Brunak S. (2004). Improved prediction of signal peptides: signalP 3.0. J. Mol. Biol. 340, 783–795. 10.1016/j.jmb.2004.05.028 [DOI] [PubMed] [Google Scholar]
- Galens K., Orvis J., Daugherty S., Creasy H. H., Angiuoli S., White O., et al. (2011). The IGS standard operating procedure for automated prokaryotic annotation. Stand. Genomic Sci. 4, 244–251. 10.4056/sigs.1223234 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Galperin M. Y., Makarova K. S., Wolf Y. I., Koonin E. V. (2015). Expanded microbial genome coverage and improved protein family annotation in the COG database. Nucleic Acids Res. 43, D261–D269. 10.1093/nar/gku1223 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Goh Y., Goin C., O'Flaherty S., Altermann E., Hutkins R. (2011). Specialized adaptation of a lactic acid bacterium to the milk environment: the comparative genomics of Streptococcus thermophilus LMD-9. Microb. Cell Fact. 10:S22. 10.1186/1475-2859-10-S1-S22 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Griffiths-Jones S., Bateman A., Marshall M., Khanna A., Eddy S. R. (2003). Rfam: an RNA family database. Nucl. Acids Res. 31, 439–441. 10.1093/nar/gkg006 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Hagen K. E., Tramp C. A., Altermann E., Welker D. L., Tompkins T. A. (2010). Sequence analysis of plasmid pIR52-1 from Lactobacillus helveticus R0052 and investigation of its origin of replication. Plasmid 63, 108–117. 10.1016/j.plasmid.2009.12.004 [DOI] [PubMed] [Google Scholar]
- Hyatt D., Chen G. L., Locascio P. F., Land M. L., Larimer F. W., Hauser L. J. (2010). Prodigal: prokaryotic gene recognition and translation initiation site identification. BMC Bioinformatics 11:119. 10.1186/1471-2105-11-119 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Kelly W. J., Leahy S. C., Li D., Perry R., Lambie S. C., Attwood G. T., et al. (2014). The complete genome sequence of the rumen methanogen Methanobacterium formicicum BRM9. Stand. Genomic Sci. 9:15. 10.1186/1944-3277-9-15 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Kingsford C. L., Ayanbule K., Salzberg S. L. (2007). Rapid, accurate, computational discovery of Rho-independent transcription terminators illuminates their relationship to DNA uptake. Genome Biol. 8:R22. 10.1186/gb-2007-8-2-r22 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Kislyuk A. O., Katz L. S., Agrawal S., Hagen M. S., Conley A. B., Jayaraman P., et al. (2010). A computational genomics pipeline for prokaryotic sequencing projects. Bioinformatics 26, 1819–1826. 10.1093/bioinformatics/btq284 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Kristensen D. M., Waller A. S., Yamada T., Bork P., Mushegian A. R., Koonin E. V. (2013). Orthologous gene clusters and taxon signature genes for viruses of prokaryotes. J. Bacteriol. 195, 941–950. 10.1128/JB.01801-12 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Krogh A., Larsson B., von Heijne G., Sonnhammer E. L. L. (2001). Predicting transmembrane protein topology with a hidden markov model: application to complete genomes. J. Mol. Biol. 305, 567–580. 10.1006/jmbi.2000.4315 [DOI] [PubMed] [Google Scholar]
- Kumar K., Desai V., Cheng L., Khitrov M., Grover D., Satya R. V., et al. (2011). AGeS: a software system for microbial genome sequence annotation. PLoS ONE 6:e17469. 10.1371/journal.pone.0017469 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Lambie S. C., Altermann E., Leahy S. C., Kelly W. J. (2014). Draft genome sequence of Lactococcus lactis subsp. cremoris HPT, the first defined-strain dairy starter culture bacterium. Genome Announc. 2:e00107-14. 10.1128/genomea.00107-14 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Lambie S. C., Kelly W. J., Leahy S. C., Li D., Reilly K., McAllister T. A., et al. (2015). The complete genome sequence of the rumen methanogen Methanosarcina barkeri CM1. Stand. Genomic Sci. 10:57. 10.1186/s40793-015-0038-5 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Leahy S. C., Kelly W. J., Altermann E., Ronimus R. S., Yeoman C. J., Pacheco D. M., et al. (2010). The genome sequence of the rumen methanogen Methanobrevibacter ruminantium reveals new possibilities for controlling ruminant methane emissions. PLoS ONE 5:e8926. 10.1371/journal.pone.0008926 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Leahy S. C., Kelly W. J., Li D., Li Y., Altermann E., Lambie S. C., et al. (2013). The complete genome sequence of Methanobrevibacter sp. AbM4. Stand. Genomic Sci. 8, 215–227. 10.4056/sigs.3977691 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Liao Y. C., Lin H. H., Sabharwal A., Haase E. M., Scannapieco F. A. (2015). MyPro: a seamless pipeline for automated prokaryotic genome assembly and annotation. J. Microbiol. Methods 113, 72–74. 10.1016/j.mimet.2015.04.006 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Lowe T. M., Eddy S. R. (1997). tRNAscan-SE: a program for improved detection of transfer RNA genes in genomic sequence. Nucleic Acids Res. 25, 955–964. 10.1093/nar/25.5.0955 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Lu Z., Altermann E., Breidt F., Kozyavkin S. (2010). Sequence analysis of Leuconostoc mesenteroides bacteriophage {Phi}1-A4 isolated from an industrial vegetable fermentation. Appl. Environ. Microbiol. 76, 1955–1966. 10.1128/AEM.02126-09 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Lugli G. A., Milani C., Mancabelli L., van Sinderen D., Ventura M. (2016). MEGAnnotator: a user-friendly pipeline for microbial genomes assembly and annotation. FEMS Microbiol. Lett. 363:fnw049. 10.1093/femsle/fnw049 [DOI] [PubMed] [Google Scholar]
- Makarova K. S., Sorokin A. V., Novichkov P. S., Wolf Y. I., Koonin E. V. (2007). Clusters of orthologous genes for 41 archaeal genomes and implications for evolutionary genomics of archaea. Biol. Direct 2:33. 10.1186/1745-6150-2-33 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Makarova K. S., Wolf Y. I., Koonin E. V. (2015). Archaeal Clusters of Orthologous Genes (arCOGs): an update and application for analysis of shared features between Thermococcales, Methanococcales, and Methanobacteriales. Life (Basel) 5, 818–840. 10.3390/life5010818 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Markowitz V. M., Chen I. M. A., Chu K., Pati A., Ivanova N. N., Kyrpides N. C. (2015). Ten years of maintaining and expanding a microbial genome and metagenome analysis system. Trends Microbiol. 23, 730–741. 10.1016/j.tim.2015.07.012 [DOI] [PubMed] [Google Scholar]
- Markowitz V. M., Chen I. M. A., Palaniappan K., Chu K., Szeto E., Pillay M., et al. (2014). IMG 4 version of the integrated microbial genomes comparative analysis system. Nucleic Acids Res. 42, D560–D567. 10.1093/nar/gkt963 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Markowitz V. M., Mavromatis K., Ivanova N. N., Chen I. M. A., Chu K., Kyrpides N. C. (2009). IMG ER: a system for microbial genome annotation expert review and curation. Bioinformatics 25, 2271–2278. 10.1093/bioinformatics/btp393 [DOI] [PubMed] [Google Scholar]
- Nelson D. M., Cann I. K. O., Altermann E., Mackie R. I. (2010). Phylogenetic evidence for lateral gene transfer in the intestine of Marine Iguanas. PLoS ONE 5:e10785. 10.1371/journal.pone.0010785 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Overmars L., Kerkhoven R., Siezen R. J., Francke C. (2013). MGcV: the microbial genomic context viewer for comparative genome analysis. BMC Genomics 14:209. 10.1186/1471-2164-14-209 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Petersen T. N., Brunak S., von Heijne G., Nielsen H. (2011). SignalP 4.0: discriminating signal peptides from transmembrane regions. Nat. Methods 8, 785–786. 10.1038/nmeth.1701 [DOI] [PubMed] [Google Scholar]
- Poptsova M. S., Gogarten J. P. (2010). Using comparative genome analysis to identify problems in annotated microbial genomes. Microbiology 156(Pt 7), 1909–1917. 10.1099/mic.0.033811-0 [DOI] [PubMed] [Google Scholar]
- Ross D. E., Marshall C. W., May H. D., Norman R. S. (2016). Comparative genomic analysis of Sulfurospirillum cavolei MES reconstructed from the metagenome of an electrosynthetic microbiome. PLoS ONE 11:e0151214. 10.1371/journal.pone.0151214 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Rutherford K., Parkhill J., Crook J., Horsnell T., Rice P., Rajandream M. A., et al. (2000). Artemis: sequence visualization and annotation. Bioinformatics 16, 944–945. 10.1093/bioinformatics/16.10.944 [DOI] [PubMed] [Google Scholar]
- Sangwan N., Xia F., Gilbert J. A. (2016). Recovering complete and draft population genomes from metagenome datasets. Microbiome 4, 1–11. 10.1186/s40168-016-0154-5 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Seemann T. (2014). Prokka: rapid prokaryotic genome annotation. Bioinformatics 30, 2068–2069. 10.1093/bioinformatics/btu153 [DOI] [PubMed] [Google Scholar]
- Sturino J. M., Rajendran M., Altermann E. (2013). Draft genome sequence of the pediocin-encoding biopreservative and biocontrol strain Pediococcus acidilactici D3. Genome Announc. 1:e00208-13. 10.1128/genomeA.00208-13 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Sturino J. M., Rajendran M., Altermann E. (2014). Draft genome sequence of Lactobacillus animalis 381-IL-28. Genome Announc. 2:e00478-14. 10.1128/genomeA.00478-14 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Suzek B. E., Ermolaeva M. D., Schreiber M., Salzberg S. L. (2001). A probabilistic method for identifying start codons in bacterial genomes. Bioinformatics 17, 1123–1130. 10.1093/bioinformatics/17.12.1123 [DOI] [PubMed] [Google Scholar]
- Tatusov R., Fedorova N., Jackson J., Jacobs A., Kiryutin B., Koonin E., et al. (2003). The COG database: an updated version includes eukaryotes. BMC Bioinformatics 4:41. 10.1186/1471-2105-4-41 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Ventura M., Canchaya C., Bernini V., Altermann E., Barrangou R., McGrath S., et al. (2006). Comparative genomics and transcriptional analysis of prophages identified in the genomes of Lactobacillus gasseri, Lactobacillus salivarius, and Lactobacillus casei. Appl. Environ. Microbiol. 72, 3130–3146. 10.1128/AEM.72.5.3130-3146.2006 [DOI] [PMC free article] [PubMed] [Google Scholar]
- Weinmaier T., Platzer A., Frank J. H., Hellinger J., Tischler P., Rattei T. (2016). ConsPred: a rule-based (re-)annotation framework for prokaryotic genomes. Bioinformatics 32, 3327–3329. 10.1093/bioinformatics/btw393 [DOI] [PubMed] [Google Scholar]
- Yeoman C. J., Kelly W. J., Rakonjac J., Leahy S. C., Altermann E., Attwood G. T. (2011). The large episomes of Butyrivibrio proteoclasticus B316T have arisen through intragenomic gene shuttling from the chromosome to smaller Butyrivibrio-specific plasmids. Plasmid 66, 67–78. 10.1016/j.plasmid.2011.05.002 [DOI] [PubMed] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.