Skip to main content
GigaScience logoLink to GigaScience
. 2018 Aug 30;7(9):giy096. doi: 10.1093/gigascience/giy096

ANNOgesic: a Swiss army knife for the RNA-seq based annotation of bacterial/archaeal genomes

Sung-Huan Yu 1, Jörg Vogel 1,2, Konrad U Förstner 1,3,4,
PMCID: PMC6123526  PMID: 30169674

Abstract

To understand the gene regulation of an organism of interest, a comprehensive genome annotation is essential. While some features, such as coding sequences, can be computationally predicted with high accuracy based purely on the genomic sequence, others, such as promoter elements or noncoding RNAs, are harder to detect. RNA sequencing (RNA-seq) has proven to be an efficient method to identify these genomic features and to improve genome annotations. However, processing and integrating RNA-seq data in order to generate high-resolution annotations is challenging, time consuming, and requires numerous steps. We have constructed a powerful and modular tool called ANNOgesic that provides the required analyses and simplifies RNA-seq-based bacterial and archaeal genome annotation. It can integrate data from conventional RNA-seq and differential RNA-seq and predicts and annotates numerous features, including small noncoding RNAs, with high precision. The software is available under an open source license (ISCL) at https://pypi.org/project/ANNOgesic/.

Keywords: genome annotation, RNA-seq, transcriptomics

Background

As the number of available genome sequences has rapidly expanded in databases, numerous tools have been developed that can detect genomic features of interest based on the genome sequence. Prominent representatives are Glimmer to identify open reading frames (ORFs) [1], tRNAscan-SE [2] to spot tRNAs, and RNAmmer to find rRNAs [3]. Pipelines such as Prokka [4] or ConsPred [5] combine such tools and are able to search multiple features in bacterial and archaeal genomes. Still, these tools make their predictions purely based on the genome sequences and can predict features such as transcriptional start sites and noncoding RNAs, if at all, only with low confidence.

Recent developments in high-throughput sequencing offer solutions to this problem. RNA sequencing (RNA-seq) has revolutionized how differential gene expression can be measured and is widely used for this purpose [6]. In addition, it has also been applied in numerous cases to improve the genome annotation of bacteria [7,8,9]archaea [10], and eukaryotes [11]. For the global detection of genomic features, several RNA-seq-based protocols have been created. For example, differential RNA-seq (dRNA-seq) [12,13] represents a method for the system-wide mapping of transcriptional start sites (TSSs). For the construction of dRNA-seq libraries, a sample is split into two aliquots: one is digested by terminator exonuclease (the TEX+ library), which degrades processed RNA molecules with 5΄-monophosphate, while the other aliquot remains untreated (TEX- library). Both subsamples are then used to generate cDNA libraries. Based on this method, primary transcripts that have a 5΄-triphosphate are enriched in the TEX+ libraries. The digestion of matured transcript in the TEX+ library leads to a relative enrichment of primary transcripts. Thus, TSSs can be identified by comparing normalized coverage values between the TEX+ and TEX- libraries [12,13]. In addition to dRNA-seq, other RNA-seq-based protocols such as Term-seq [14] and ribosome profiling [15,16] have been applied to globally detect terminators, ORFs, and riboswitches but require dedicated data processing. While there are tools that can process RNA-seq data in order to predict genome-wide features such as TSSs based on dRNA-seq data [17,18,19] or based on conventional RNA-seq data [20,21], there has been,to date, no solution that combines different predictions of genomic features and compiles them into a consistent annotation.

Here we present ANNOgesic, a modular, command-line tool that can integrate data from different RNA-seq protocols such as dRNA-seq as well as conventional RNA-seq performed after transcript fragmentation and generate high-quality genome annotations that include features missing in most bacterial annotations (e.g., small noncoding RNAs, untranslated regions [UTRs], TSSs, and operons). The central approach is to detect transcript boundaries and then subsequently attach additional information about type as well as function to the predicted features and also to infer interactions between them. Several of ANNOgesic’s core functions represent new implementations that are not found in other programs. Third-party tools embedded into ANNOgesic are accessible via a consistent command-line interface. Furthermore, their results are improved, e.g., by dynamic parameter optimizations or by removing false positives. Numerous visualizations and statistics help the user to quickly evaluate the feature predictions. The tool is modular and has been intensively tested with several RNA-seq datasets from bacterial as well as from archaeal species.

Materials and Methods

Modules of ANNOgesic

ANNOgesic consists of the following modules, their names indicate their functions: Sequence modification, Annotation transfer, SNP/Mutation, Transcript, TSS, Terminator, UTR, Processing site (PS), Promoter, Operon, sRNA, sRNA target, small ORF (sORF), Gene Ontology (GO) term, Protein-protein interaction network, Subcellular localization, Riboswitch, RNA thermometer, Circular RNA, and Clustered regularly interspaced short palindromic repeat (CRISPR). Several potential workflows connecting these modules are displayed in Supplementary Fig. S1. An overview of the novelties and improvements of the modules in ANNOgesic are listed in Supplementary Table S1, and all the dependencies of ANNOgesic are shown in Supplementary Table S2.

Depending on the task, ANNOgesic requires a specific set of input information, either as coverage information in wiggle format or alignments in binary alignment map (BAM) format. This can be generated by short-read aligners such as STAR [22], segemehl [23], or a full RNA-seq pipeline such as READemption [24]. Certain modules additionally require annotations in GFF3 format. In case a sufficient genome annotation is not available, ANNOgesic can perform an annotation transfer from a closely related strain based on fasta and GFF3 files provided by the user.

Implementation and installation

ANNOgesic’s source code is implemented in Python 3 and hosted at https://pypi.org/project/ANNOgesic/. The comprehensive documentation can be found at http://annogesic.readthedocs.io/, and releases are automatically submitted to Zenodo (https://zenodo.org/) to guarantee long-term availability. It can be easily installed using pip (https://pip.pypa.io). In order to provide a frictionless installation including non-Python dependencies, we additionally offer a Docker image at (https://hub.docker.com/r/silasysh/annogesic/) [25].

Optimization of the parameter set for TSSpredator

For several parts of ANNOgesic, the selection of parameters has a strong impact on the final results. Especially the TSS prediction, building on TSSpredator [17], requires a sophisticated fine-tuning of several parameters (namely, height, height reduction, factor, factor reduction, enrichment factor, processing site factor, and base height). To overcome the hard task of manual parameter selection, ANNOgesic optimizes the parameters by applying a genetic algorithm, a machine learning approach, [26] that is trained based on a small user-curated set of TSS predictions. This approach has the advantage of being able to find global, not only local, optima. The process of optimization is composed of three parts: random change, large change, and small change (Fig. 1). In this context, a global change means a random allocation of values to all parameters; a large change is a random allocation of values to two parameters; and a small change is adding or subtracting a small fraction to or from one parameter value. The result of each iteration is evaluated by a decision statement (Equation 1).

graphic file with name M1.gif (1)
graphic file with name M2.gif (2)
graphic file with name M3.gif (3)
graphic file with name M4.gif (4)
graphic file with name M5.gif (5)
graphic file with name M6.gif (6)

In Equation 1, TPm is the number of manually detected TSSs. TPc/TPRc represents the true positive/true positive rate of the current parameters. TPb/TPRb represents the true positive/true positive rate of the best parameters. FPc/FPRc represents the false- positive/false-positive rate of the current parameters. FPb/FPRb represents the false- positive/false-positive rate of the best parameters. If one of these six situations is true, it will replace the best parameters with current parameters.

Figure 1:

Figure 1:

Schema of the genetic algorithm for optimizing the parameters of TSSpredator. It starts from the default parameters. These parameter sets will go through three steps: global change (change every parameter randomly), large change (change two of the parameters randomly), and then small change (adds/subtracts a small fraction to one of the parameters). It will then select the best parameter set for reproduction when one step is done. Usually, ANNOgesic can achieve the optimized parameters within 4,000 runs.

Test datasets

In order to test ANNOgesic’s performance, we applied it to RNA-seq datasets originating from Helicobacter pylori 26695 [7,13] and Campylobacter jejuni 81116 [17]. The dRNA-seq datasets were retrieved from (National Center for Biotechnology Information (NCBI) GEO where they are stored under the accession numbers GSE67564 and GSE38883, respectively. For H. pylori conventional RNA-seq data, i.e., without TEX treatment (which degrades transcripts without a 5’-triphosphate) and with fragmentation of the transcript before the library preparation, was also retrieved from NCBI SRA (accession number SRR031126). Moreover, for assessing the performance of ANNOgesic, dRNA-seq, and conventional RNA-seq datasets of Escherichia coli, K-12 MG1655 were downloaded from NCBI GEO (accession numbers GSE55199 and GSE45443; only the data of the wild-type strain were retrieved) [21,27]. The ANNOgesic predictions generated using these datasets of E. coli K-12 MG1655 were compared to the databases RegulonDB, EcoCyc, and DOOR2 [2833]

Results

Correction of genome sequences and annotations

All genomic features that can be detected by ANNOgesic are listed in Table 1. In order to demonstrate and test ANNOgesic’s performance, we analyzed RNA-seq data of H. pylori 26695 and C. jejuni 81116 and discuss the prediction results as examples in the following sections.

Table 1:

Overview of feature predictions for H. pylori 26695 and C. jejuni 81116

H. pylori 26695 C. jejuni 81116
Gene 1560 1685
Coding sequence (CDS) Total 1448 1630
Expressed 1406 1513
Transcript 1716 1147
TSS Total 2458 1242
Primary 703 565
Secondary 156 92
Internal 719 360
Antisense 1161 510
Orphan 111 30
Processing site 281 345
Terminator Total 820, (437) 874, (375)
TransTermHP 631, (314) 655, (269)
Convergent genes 229, (151) 276, (145)
UTR 5’ UTR 693 560
3’ UTR 325 286
sRNA Total 184 40
Intergenic 60 16
Antisense 85 21
5’ UTR-derived 10 0
3’ UTR-derived 23 2
InterCDS-derived 6 1
Operon Total 554 710
Monocistronic 268 386
Polycistronic 286 324
sORF 150 25
Riboswitch 3 5
RNA thermometer 1 1
circular RNA 0 1
CRISPR 0 1, (8)

The numbers in parentheses for terminator and CRISPR represent occurrences of terminators with coverage drop and repeat units of CRISPR, respectively. For the prediction of terminators, ANNOgesic only keeps the high confidence ones in case a coding sequence (CDS) is associated with multiple terminators.

Genome sequence improvement and single nucleotide polymorphism/mutation calling

Conventionally, differences in the genome sequence of a strain of interest and the reference strain are determined by DNA sequencing. However, RNA-seq reads can also be repurposed to detect such single nucleotide polymorphisms (SNPs) or mutations that occur in transcribed regions, which can help to save the resources required for dedicated DNA sequencing or DNA SNP microarray measurements. The two drawbacks of this method are that only locations that are expressed can be analyzed and that, due to RNA editing, changes could be present only in the RNA level and are not found in the genome. On the other hand, it has been shown to be a valid approach for eukaryotic species and that the majority of SNPs are found in the expressed transcripts [34,35]. Such analysis could be useful to generate hypotheses that then need to be tested with complementary methods. ANNOgesic can perform SNPs/mutation calling via SAMtools [36] and BCFtools [36] applying read counting-based filtering.

Annotation transfer

ANNOgesic integrates the Rapid Annotation Transfer Tool [37], which can detect the shared synteny and mutations between a reference and query genome to transfer annotation (i.e., genes, CDSs, tRNAs, rRNAs) by applying MUMmer [38]. For the chosen strains, H. pylori 26695 and C. jejuni 81116 annotation files in GFF3 format were obtained from NCBI RefSeq. Because of this, there was no need to transfer the annotation from a closely related strain.

Detection of transcripts

Knowing the exact boundaries and sequence of a transcript is crucial for a comprehensive understanding of its behavior and function. For example, UTRs can be the target of regulation by sRNAs or small molecules (e.g., riboswitches) [39,40] or even sources of sRNAs [41]. Unfortunately, most bacterial annotations only cover the protein-coding regions, while the information about TSSs, terminators, and UTRs is lacking. To address this issue, ANNOgesic combines several feature predictions for a reliable detection of transcripts and their boundaries (Fig. 2).

Figure 2:

Figure 2:

Transcript boundary detection. (A) Schema: ANNOgesic can predict TSSs, terminators, transcripts, genes, and UTRs and integrate them into a comprehensive annotation. (B) Gene HP1342 of H. pylori 26695 as an example. The pink coverage plot represents RNA-seq data of libraries after fragmentation, the blue coverage plots TEX+ libraries of dRNA-seq, and the green coverage plots TEX- libraries of dRNA-seq. Transcript, TSS, terminator, and CDS are presented as red, blue, orange, and green bars, respectively. The figure shows how the transcript covers the whole gene location and how UTRs (presented by purple bars) can be detected based on the TSS, transcript, terminator, and gene annotations.

Coverage-based transcript detection

There are numerous tools available for the detection of transcripts (e.g., [42]), but most of them are optimized for the assembly of eukaryotic transcripts. Because of this, we combined several heuristics to perform such predictions. Nucleotide coverage data are used for defining the expressed regions, and genome annotations are applied for extending or merging the gene expressed regions to form complete transcripts. Several parameters such as the threshold of coverage values can be set by the user to fine-tune the predictions (Fig. 3).

Figure 3:

Figure 3:

Coverage-based transcript detection. If the coverage (blue curve-blocks) is higher than a given coverage cutoff value (dashed line), a transcript will be called. The user can set a tolerance value (i.e., a number of nucleotides with a coverage below the cutoff) on which basis gapped transcripts are merged or are kept separated. Information of gene positions can also be used to merge transcripts in case two of them overlap with the same gene.

By running ANNOgesic’s subcommand for transcript prediction, we detected 1,716 transcripts in H. pylori 26695 and 1,147 transcripts in C. jejuni 81116. These transcripts cover 1,520 and 1,568 genes, which shows that 97% and 93% of the known genes are expressed in at least one condition, respectively.

Transcriptional start sites

For the prediction of TSSs, ANNOgesic builds on TSSpredator [17], which takes dRNA-seq coverage data as input. The outcome of TSSpredator’s predictions depends strongly on the setting of numerous parameters, and fine-tuning those can be time consuming. Because of this, a parameter optimization was implemented in ANNOgesic that builds on a small, manually curated set of TSSs to find optimal values.

In order to test the performance of ANNOgesic, we manually annotated TSSs in the first 200 kb of the genome of H. pylori 26695 and C. jejuni 81116 (Supplementary Tables S5 and S6). This set was used to perform the predictions of TSSpredator with default settings as well with the parameters optimized by ANNOgesic. For the test set of the benchmarking, we manually annotated TSSs from first 200 kb to 400 kb in the genome of H. pylori 26695 and C. jejuni 81116 (Supplementary Tables S5 and S6). As displayed in Table 2, the optimization had minor sensitivity improvements in H. pylori 26695 (from 96.8% to 99.6%); it strongly increased the sensitivity for the TSS prediction for C. jejuni 81116 (67.1% to 98.7%) while keeping the same level of specificity. To underpin those findings, we looked at the overlap of the predicted TSS and predicted transcripts. This was nearly the same for H. pylori 26695 (82% for default and 83% for optimized setting) but also increased significantly for C. jejuni 81116 from 81% for default parameters to 96% with optimized parameters.

Table 2:

Comparison of default and optimized parameters of TSSpredator for TSS and PS prediction

Strain Parameter Sensitivity (TP) Specificity (FP)
TSS
H. pylori 26695 Default 96.8% (244) 99.98% (32)
Optimization 99.6% (251) 99.98% (32)
C. jejuni 81116 Default 67.1% (104) 99.98% (31)
Optimization 98.7% (153) 99.99% (7)
PS
H. pylori 26695 Default 92.9% (26) 99.99% (7)
Optimization 92.9% (26) 99.99% (7)
C. jejuni 81116 Default 61.3% (19) 99.99% (2)
Optimization 93.5% (29) 99.99% (6)

The numbers in parentheses represent true positive or false positive.

Moreover, TSSs are classified depending on their relative positions to genes by TSSpredator. Based on these classifications, Venn diagrams representing the different TSS classes are automatically generated (Supplementary Fig. S2).

Processing sites

Several transcripts undergo processing, which influences their biological activity [41,43]. In order to detect PSs based on dRNA-seq data, ANNOgesic facilitates the same approach as described for TSS detection but searches for the reverse enrichment pattern, i.e., a relative enrichment in the library not treated with TEX in comparison to the library treated with TEX. This coverage pattern is observed as the TEX enzyme will not degrate processed transcripts due to the missing triphosphate at the 5’end, which leads to a relative enrichment in samples. As done for the TSSs, we manually annotated the PSs in the first 200 kb of the genomes by looking for such enrichment patterns. Based on these manually curated sets, we performed parameter optimization on the test set (manually curated from the first 200 kb to 400 kb; Supplementary Tables S7 and S8, Table 2) and could improve the prediction of PSs by TSSpredator [17]. With optimized parameters 281 and 345, PSs were detected in H. pylori 26695 and C. jejuni 81116, respectively.

ρ-independent terminators

While the TSSs are in general clearly defined borders, the 3’-end of a transcript is often not very sharp. A commonly used tool for the prediction of the 3’-end of a transcript is TransTermHP [44], which detects ρ-independent terminators based on genome sequences. Manual inspection showed us that TransTermHP predictions are not always supported by the RNA-data (Supplementary Fig. S3E and S3F). This could be due to the lack of expression in the chosen conditions. Additionally, certain locations in 3’-ends that may be ρ-independent were not detected by TransTermHP. Because of this, we extended the prediction by two additional approaches based on RNA-seq coverage and the given genome sequence. At first, terminators predicted by TransTermHP that show a significant decrease of coverage are marked as high-confidence terminators. For this, the drop of coverage inside the predicted terminator region plus 30 nucleotides upstream and downstream is considered sufficient if the ratio of the lowest coverage value and the highest coverage value is at a user-defined value (the default value is 0.5, and the schemes and examples are shown in Supplementary Fig. S3). In order to improve the sensitivity, an additional heuristic for the detection of ρ-independent terminators was developed. In this approach, only converging gene pairs (i.e., the 3’-end are facing each other) are taken into account (Supplementary Fig. S4). In case the region between the two genes is A/T-rich and a stem-loop can be predicted in there, the existence of a ρ-independent terminator is assumed. As a default, the region should consist of 80 or fewer nucleotides, the T-rich region should contain more than 5 thymines, the stem-loop needs to be 4-20 nucleotides, the length of the loop needs to be between 3 and 10 nucleotides, and a maximum of 25% of the nucleotides in the stem should be unpaired.

UTRs

Based on the CDS locations and the above-described detection of TSSs, terminators, and transcripts, 5’ UTR and 3’ UTR can be annotated by ANNOgesic. Additionally, it visualizes the distribution of UTR lengths in a histogram (as shown in Supplementary Fig. S5).

Promoters

ANNOgesic integrates MEME [45], which detects ungapped motifs, and GLAM2 [46], which discovers gapped motifs, for the detection and visualization of promoter motifs. The user can define the number of nucleotides upstream of TSSs that should be screened and the length of potential promoter motifs. The motifs can be generated globally or for the different types of TSSs (example in Supplementary Fig. S6).

Operons

Based on the TSS and transcript prediction, ANNOgesic can generate statements regarding the organization of genes in operons and suboperons as well as report the number of monocistronic operons and polycistronic operons (Fig. 4).

Figure 4:

Figure 4:

Operon and sub-operon detection. (A) If there is more than one TSSs that does not overlap with genes located within one operon, the operon can be divided to several sub-operons based on these TSSs. (B) An example from H. pylori 26695. The coverage of RNA-seq with fragmentation, TEX+, and TEX- of dRNA-seq are shown in pink, blue, and green coverages, respectively. TSSs, transcripts/operons, and genes are presented as blue, red, and green bars, respectively. The two genes are located in the same operon but also in different sub-operons (two empty red squares).

Detection of sRNAs and their targets

The detection of sRNAs based on RNA-seq data is a nontrivial task. While numerous sRNAs are found in intergenic regions, several cases of 5’ and 3’ UTR-derived sRNAs are reported [41,47, 48,49]. ANNOgesic offers the detection of all classes combined with a detailed characterization of the sRNA candidates (Fig. 5).

Figure 5:

Figure 5:

Detection of intergenic, antisense, and UTR-derived sRNAs. The length of potential sRNAs should be within a given range, and their coverages should exceed a given minimum coverage. (A) Detection of intergenic and antisense sRNAs. Three potential cases are shown. In the upper panel, the transcript starts with a TSS, and length of the transcript is within the expected length. In the middle panel, the transcript starts with a TSS, but the transcript is longer than an average sRNA. In that case, ANNOgesic will search in the region of high coverage (blue region) for a point at which the coverage is decreasing rapidly. In the bottom panel, the image is identical to the one in the middle, but the sRNA ends instead with a PS. (B) Detection of UTR-derived sRNAs. For 3’ UTR-derived sRNAs: if the transcript starts with a TSS or PS, it will be tagged as a 3’ UTR-derived sRNA. For 5’ UTR-derived sRNAs: if the transcript starts with a TSS and ends with a PS or the point where the coverage significant drops. (C) Detection of interCDS-derived sRNAs; this is similar to the 5’ UTR-derived approach, but the transcript starts with a PS.

In order to classify newly detected intergenic transcripts as sRNAs, ANNOgesic tests several of their features. If a Basic Local Alignment Search Tool + [50] search of a transcript finds homologous sequences in BSRD [51], a database that stores experimentally confirmed sRNAs, the transcript gets the status of an sRNA. The user can also choose additional databases for searching homologous sequences. In case a search against the NCBI nonredundant protein database leads to a hit, it is marked as potentially protein-coding. Otherwise, a transcript must have a predicted TSS, form a stable secondary structure (i.e., the folding energy change calculated with RNAfold from Vienna RNA package [52] must be below a user-defined value), and their length should be in the range of 30 to 500 nt in order to be tagged as an sRNA. All these requirements are used per default but can be modified or removed via ANNOgesic’s command line parameters. ANNOgesic stores the results of all analyses and generates GFF3 files, fasta files, secondary structural figures, dot plots, as well as mountain plots based on those predictions.

For sRNAs that share a transcript with CDSs—5’ UTR, inter-CDS, or 3’ UTR located sRNAs—we implemented several detection heuristics (Fig. 5B and 5C). The 5’ UTR-derived sRNAs must start with a TSS and show a sharp drop of coverage or a PS in the 3’-end. The requirement for the detection of inter-CDS located sRNAs is either a TSS or a PS as well as a coverage drop at the 3’-end or a PS. Small RNAs derived from the 3’ UTR are expected to have a TSS or a PS and either end with the transcript or at a PS. After the detection of a bona fide sRNA, the above-described quality filters (e.g., length range, secondary structure) are applied to judge the potential of a candidate (examples are shown in Supplementary Figs. S7, S8). For the validation of sRNA candidates in our test case, the described sRNAs of two publications were chosen. Sharma et al. [7] described 63 sRNAs of which 4 were not expressed in the condition of the test dataset (removed from the dataset) (Supplementary Fig. S9). Of these 59, 53 (90%) were detected by ANNOgesic. In the C. jejuni 81116 set, 31 sRNAs were described by Dugar et al. [17], and ANNOgesic could recover 26 (84%). The sRNA ranking system provided by ANNOgesic is displayed in Supplementary Fig. S10 and Supplementary Equation S1.

In order to deduce potential regulatory functions of newly predicted sRNAs, ANNOgesic performs prediction of interaction between them and mRNAs using RNAplex [52,53], RNAup [52,54], and IntaRNA [55]. The user can choose if only interactions supported by all tools are reported.

Detection of sORFs

All newly detected transcripts that do not contain a previously described CDS as well all 5’ UTRs and 3’ UTRs are scanned for potential sORFs [56] (Fig. 6). For this, ANNOgesic searches for start and stop codons (noncanonical start codons are not included but can be assigned by the user) that constitute potential ORFs of 30 to 150 base-pairs. Furthermore, ribosomal binding sites (based on the Shine-Dalgarno sequence, but different sequences can be assigned as well) between the TSS and 3 to 15 bp upstream of the start codon are required for a bona fide sORF.

Figure 6:

Figure 6:

sORF detection. (A) An sORF must contain a start codon and stop codon within a transcript and should be inside of a given length range (default 30 -150nt). Additionally, a ribosomal binding site must be detected between the TSS and the start codon. (B) An example from H. pylori 26695. The coverage of RNA-seq (fragmented libraries), TEX+, and TEX- (dRNA-seq) are shown as pink, blue, and green coverages, respectively. The TSS, transcript, and sORF are presented as blue, red, and green bars, respectively.

Detection of functional-related attributes

In order to facilitate a better understanding of the biological function of known and newly detected transcripts, ANNOgesic predicts several attributes for these features.

This includes the allocation of GO as well as GOslim [57] terms to CDSs via searching of protein ids in Uniprot [58]. The occurrence of groups is visualized for expressed and nonexpressed CDSs (Supplementary Fig. S11). Furthermore, the subcellular localization is predicted by PSORTb [59] for the proteins (Supplementary Fig. S12). Additionally, the protein entries are enriched by protein-protein interaction information retrieved from STRING [60] and PIE [61] (examples in Supplementary Fig. S13).

Circular RNAs

ANNOgesic integrates the tool ”testrealign.x” from the segemehl package for the detection of circular RNAs [62] and adds a filter to reduce the number of false positive. Candidates for circular RNAs must be located in intergenic regions and exceed a given number of reads.

CRISPRs

CRISPR/Cas systems represent a bacterial defense system against phages and consist of repeat units and spacer sequences as well as Cas proteins [63]. The CRISPR Recognition Tool [64] is integrated into ANNOgesic and extended by comparison of CRISPR/Cas candidates to other annotations to remove false positive (Supplementary Fig. S14).

Riboswitches and RNA thermometers

Riboswitches and RNA thermometers are regulatory sequences that are part of transcripts and influence the translation based on the concentration of selected small molecules and temperature change, respectively. For the prediction of these riboswitches and RNA thermometers, ANNOgesic searches [65] the sequences that are between TSSs (or starting point of a transcript if no TSS was detected) and downstream CDSs, as well as those associated with ribosome binding site in the Rfam database using Infernal [66].

Comparison between ANNOgesic predictions and published databases for E. coli K-12

In order to assess the performance of ANNOgesic, we compared its predictions based on a dRNA-seq dataset and conventional RNA-seq of E. coli K-12 MG1655 by Thomason et al. [27] and McClure et al. [21] with the entries in several databases [28–33]. Most of the benchmarking features can be precisely detected (80% or more) (Supplementary Table S3). Moreover, the predicted features not found in published databases have the high possibility to be novel features that are strongly supported by RNA-seq data (Supplementary Fig. S7B, S7D). TSSs represent an exception with lower success rates, and we assume this is mostly due to the higher sensitivity of the dRNA-seq method in comparison to older protocols. To test this assumption and to investigate the quality of the TSS entries in RegulonDB, we compared the three deposited TSS datasets (Salgado et al. generated with Illumina RNA-seq as well as Mendoza-Vargas et al. generated with Roche 454 high-throughput pyrosequencing and generated with Roche 5’RACE [67,68]) to each other and found very small overlap (Supplementary Fig. S15). Additionally, the 50 nucleotides upstream of TSSs were extracted and scanned with MEME [45] for common motifs that are similar to the ones described for promoters. Only for a small number, 0% to 7%, of TSSs such motifs were found (Supplementary Table S4), while 80% of the TSS predictions from ANNOgesic have such a promoter motif located upstream (Supplementary Figure S6C). The same analysis could not be performed with EcoCyc [28], which is lacking TSS information and provides only positions but no strand information for promoters. Because of these results, we doubt that the data in those databases represent a solid ground for benchmarking the accuracy of ANNOgesic’s TSS predictions.

Discussion

While RNA-seq has become a powerful method for annotating genomes, the integration of its data is usually very laborious and time consuming. It requires bioinformatic expertise and involves the application of different programs to perform the different required steps. Here, we present ANNOgesic, a modular, user-friendly annotation tool for the analysis of bacterial RNA-seq data that integrates several tools, optimizes their parameters, and includes novel prediction methods for several genomic features. With the help of this command-line tool, RNA-seq data can be efficiently used to generate high-resolution annotations of bacterial genomes with very little manual effort. In addition to the annotation files in standard formats, it also returns numerous statistics and visualizations that help the user to explore and to evaluate the results. While it ideally integrates conventional RNA-seq (beneficial for detecting 3’-ends of transcripts) as well as dRNA-seq (required for the efficient detection of internal TSSs) as input together (see Supplementary Figs. S16 and S17), it can also perform sufficient predictions with only one class of data for the majority of the genomic features (Supplementary Table S3).

Here, we demonstrated the performance of ANNOgesic by applying it on two published datasets and comparing the results to manually conducted annotations. ANNOgesic could detect 90% and 83% of the manually annotated sRNAs H. pylori 26695 and C. jejuni 81116, respectively. The sRNAs missed by ANNOgesic can be explained by low coverage, not being associated with TSSs or lack of expression in the assayed conditions (see Supplementary Figs. S18 and S19).

In addition to the analyses presented as examples in this study (H. pylori 26695 and C. jejuni 81116), ANNOgesic was successfully applied for detecting transcripts, sRNAs, and TSSs in additional annotation projects (e.g., Pseudomonas aeruginosa [69] and Rhodobacter sphaeroides [70]). Despite the fact that the program was developed mainly with a focus on bacterial genomes, it has also been used to annotate archaeal genomes (namely Methanosarcina mazei [Lutz et al., unpublished]) and eukaryotic genomes that have no introns (Trypanosoma brucei [Müller et al., unpublished]).

ANNOgesic is freely available under the OSI-compliant ISCL open source license (some of the dependencies are available under other FLOSS licenses), and extensive documentation has been produced to guide novice and advanced users.

Conclusions

ANNOgesic is a powerful tool for annotating genome features based on RNA-seq data from multiple protocols. ANNOgesic not only integrates several available tools but also improves their performance by optimizing parameters and removing false positives. For the genomic features that cannot be detected using available tools, several novel methods have been developed and implemented as part of ANNOgesic. Comprehensive documentation and useful statistics as well as visualizations are also provided by ANNOgesic.

Availability of supporting source code and requirements

Supplementary Material

GIGA-D-18-00029-Original_Submission.pdf
GIGA-D-18-00029_Revision_1.pdf
GIGA-D-18-00029_Revision_2.pdf
Response_to_Reviewer_Comments_Original_Submission.pdf
Response_to_Reviewer_Comments_Revision1.pdf
Reviewer_1_Report_(Original_Submission) -- A. Rebecca Wattam

02-26-2018 Reviewed

Reviewer_2_Report_(Original_Submission).pdf -- Raquel Tobes, Ph.D

04-14-2018 Reviewed

Reviewer_3_Report_(Original_Submission).pdf -- Roy Chaudhuri

07-17-2018 Reviewed

Reviewer_3_Report_Revision_1.pdf -- Roy Chaudhuri

07-06-2018 Reviewed

Supplement_Files.zip

ACKNOWLEDGEMENTS

We thank several colleagues for fruitful discussion, especially Sarah Svensson, Lars Barquist, and Thorsten Bischler for comments regarding the manuscript, and Diarmaid Tobin and Till Sauerwein for giving feedback regarding code and documentation.

Availability of supporting data

Snapshots of the code and data are available in the GigaScience repository, GigaDB [71]. Code and data are also available via the Code Ocean reproducibility platform [72]. For information on the supporting files, please check the documentation (http://annogesic.readthedocs.io/en/latest/subcommands.html).

Additional files

Figure S1: Workflow charts of ANNogesic modules.

Figure S2: Distribution of TSS classes.

Figure S3: Concept and examples for detecting coverage decrease of terminators.

Figure S4: Terminator prediction approach based on convergent genes.

Figure S5: Length distribution of UTRs.

Figure S6: The promoter motifs detected in Helicobacter pylori 26695, Campylobacter jejuni 81116, and Escherichia coli K-12 MG1655.

Figure S7: Examples of known and novel intergenic sRNAs that ANNOgesic can detect.

Figure S8: Examples of detected antisense and UTR derived sRNAs.

Figure S9: The coverage plots of the benchmarking sRNA HPnc4620.

Figure S10: Histograms of ranking number of the sRNA benchmarking set.

Figure S11: The distributions of GO term.

Figure S12: The distributions of subcellular localizations.

Figure S13: Visualization of protein-protein interactions.

Figure S14: The example of CRISPR in Campylobacter jejuni 81116.

Figure S15: The overlap of three previously published TSS datasets in RegulonDB.

Figure S16: The predicted sRNA which can be detected only in data RNA-seq after transcript fragmentation.

Figure S17: The comparison between dRNA-seq and RNA-seq after transcript fragmentation for detecting transcript

Figure S18: The lowly expressed sRNA - HPnc4610.

Figure S19: An example of known sRNA – CJnc230 – which is not associated with a TSS.

Equation S1: The ranking system of sRNA prediction.

Table S1: The novelties and improvements of genomic feature detection in ANNOgesic.

Table S2: The dependencies of the modules of ANNOgesic.

Table S3: The comparison between ANNOgesic predictions and several databases.

Table S4: The number of TSSs and their associated promoter motifs in RegulonDB.

Table S5: The manually-curated TSS set of Helicobacter pylori 26695 (1-400bp).

Table S6: The manually-curated TSS set of Campylobacter jejuni 81116 (1-400bp).

Table S7: The manually-curated PS set of Helicobacter pylori 26695 (1-400bp).

Table S8: The manually-curated PS set of Campylobacter jejuni 81116 (1-400bp).

Abbreviations

CDS: coding sequence; CRISPR: clustered regularly interspaced short palindromic repeat; dRNA-seq: differential RNA sequencing; GO: Gene Ontology; nt: nucleotide; PS: processing site; sORF: small open reading frame; SNP: single nucleotide polymorphism; TSS: transcriptional start site; UTR: untranslated region.

Competing interests

The authors declare that they have no competing interests.

Funding

The project was funded by the German Research Foundation as part of the Transregio 34 (CRC-TRR34).

References

  • 1. Delcher AL, Bratke KA, Powers EC et al. . Identifying bacterial genes and endosymbiont DNA with Glimmer. Bioinformatics. 2007;23:673–9. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 2. Schattner P, Brooks AN, Lowe TM. The tRNAscan-SE, snoscan and snoGPS web servers for the detection of tRNAs and snoRNAs. Nucleic Acids Res. 2005;33:W686–9. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 3. Lagesen K, Hallin P, Rodland EA, et al. . RNAmmer: consistent and rapid annotation of ribosomal RNA genes. Nucleic Acids Res. 2007;35:3100–8. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 4. Seemann T. Prokka: rapid prokaryotic genome annotation. Bioinformatics. 2014;30:2068–9. [DOI] [PubMed] [Google Scholar]
  • 5. Weinmaier T, Platzer A, Frank J, et al. . ConsPred: a rule-based (re-)annotation framework for prokaryotic genomes. Bioinformatics. 2016;32:3327–9. [DOI] [PubMed] [Google Scholar]
  • 6. Mutz KO, Heilkenbrinker A, Lönne M, et al. . Transcriptome analysis using next-generation sequencing. Curr Opin Biotech. 2013;24:22–30. [DOI] [PubMed] [Google Scholar]
  • 7. Sharma CM, Hoffmann S, Darfeuille F, et al. . The primary transcriptome of the major human pathogen Helicobacter pylori. Nature. 2010;464:250–5. [DOI] [PubMed] [Google Scholar]
  • 8. Bohn C, Rigoulay C, Chabelskaya S et al. . Experimental discovery of small RNAs in Staphylococcusaureus reveals a riboregulator of central metabolism. Nucleic Acids Res. 2010;38:6620–36. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 9. Beauregard A, Smith E, Petrone B, et al. . Identification and characterization of small RNAs in Yersinia pestis. RNA Biol. 2013;10:397–405. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 10. Wurtzel O, Sapra R, Chen F et al. . A single-base resolution map of an archaeal transcriptome. Genome Research. 2010;20:133–41. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 11. Harrow J, Frankish A, Gonzalez JM, et al. . GENCODE: the reference human genome annotation for The ENCODE Project. Genome Research. 2012;22:1760–74. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 12. Sharma CM, Vogel J. Differential RNA-seq: the approach behind and the biological insight gained. Curr Opin in Microbiol. 2014;19:97–105. [DOI] [PubMed] [Google Scholar]
  • 13. Bischler T, Tan HS, Nieselt K et al. . Differential RNA-seq (dRNA-seq) for annotation of transcriptional start sites and small RNAs in Helicobacter pylori. Methods. 2015;86:89–101. [DOI] [PubMed] [Google Scholar]
  • 14. Dar D, Shamir M, Mellin JR et al. . Term-seq reveals abundant ribo-regulation of antibiotics resistance in bacteria. Science. 2016;352:aad9822. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 15. Ingolia NT. Ribosome profiling: new views of translation, from single codons to genome scale. Nat Rev Genet. 2014;15:205–13. [DOI] [PubMed] [Google Scholar]
  • 16. Wang J, Rennie W, Liu C, et al. . Identification of bacterial sRNA regulatory targets using ribosome profiling. Nucleic Acids Res. 2015;43:10308–20. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 17. Dugar G, Herbig A, Förstner KU et al. . High-resolution transcriptome maps reveal strain-specific regulatory features of multiple Campylobacterjejuniisolates. PLoS Genet. 2013;9:e1003495. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 18. Jorjani H, Zavolan M. TSSer: An automated method to identify transcription start sites in prokaryotic genomes from differential RNA sequencing data. Bioinformatics. 2014;30:971–4. [DOI] [PubMed] [Google Scholar]
  • 19. Amman F, Wolfinger MT, Lorenz R et al. . TSSAR: TSS annotation regime for dRNA-seq data. BMC Bioinformatics. 2014;15:89. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 20. Sallet E, Gouzy J, Schiex T. EuGene-PP: a next-generation automated annotation pipeline for prokaryotic genomes. Bioinformatics. 2014;30:2659–61. [DOI] [PubMed] [Google Scholar]
  • 21. McClure R, Balasubramanian D, Sun Y, et al. . Computational analysis of bacterial RNA-seq data. Nucleic Acids Res. 2013;41:e140. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 22. Dobin A, Davis CA, Schlesinger F, et al. . STAR: ultrafast universal RNA-seq aligner. Bioinformatics. 2013;29:15–21. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 23. Hoffmann S, Otto C, Kurtz S et al. . Fast mapping of short sequences with mismatches, insertions and deletions using index structures. PLoS Comput Biol. 2009;5:e1000502. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 24. Förstner KU, Vogel J, Sharma CM. READemption-a tool for the computational analysis of deep-sequencing-based transcriptome data. Bioinformatics. 2014;30:3421–3. [DOI] [PubMed] [Google Scholar]
  • 25. Merkel D. Docker: Lightweight Linux Containers for Consistent Development and Deployment. Linux Journal; 2014. [Google Scholar]
  • 26. Goldberg DE. Genetic Algorithms in Search, Optimization, Machine Learning. Addison-Wesley Pub. Co, Reading, Mass; 1989. [Google Scholar]
  • 27. Thomason MK, Bischler T, Eisenbart SK et al. . Global transcriptional start site mapping using differential RNA sequencing reveals novel antisense RNAs in Escherichia coli. J Bacteriol. 2015;197(1)18–28. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 28. Keseler IM, Collado-Vides J, Santos-Zavaleta A et al. . EcoCyc: a comprehensive database of Escherichia coli biology. Nucleic Acids Res. 2011;39:D583–90. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 29. Mao X, Ma Q, Zhou C, et al. . DOOR 2.0: presenting operons and their functions through dynamic and integrated views. Nucleic Acids Res. 2014;42:D654 – 659. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 30. Gama-Castro S, Salgado H, Santos-Zavaleta A et al. . RegulonDB version 9.0: high-level integration of gene regulation, coexpression, motif clustering and beyond. Nucleic Acids Res. 2016;44:D133–43. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 31. Pruitt KD, Tatusova T, Klimke W et al. . NCBI feference sequences: current status, policy and new initiatives. Nucleic Acids Res. 2009;37:D32–6. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 32. Hemm MR, Paul BJ, Schneider TD, et al. . Small membrane proteins found by comparative genomics and ribosome binding site models. Molecular Microbiology. 2008;70(6)1487–1501. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 33. Grissa I, Vergnaud G, Pourcel C. The CRISPRdb database and tools to display CRISPRs and to generate dictionaries of spacers and repeats. BMC Bioinformatics. 2007;8(1):172. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 34. Chepelev I, Wei G, Tang Q, et al. . Detection of single nucleotide variations in expressed exons of the human genome using RNA-seq. Nucleic Acids Res. 2009;37:e106. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 35. Cirulli ET, Singh A, Shianna KV et al. . Screening the human exome: a comparison of whole genome and whole transcriptome sequencing. Genome Biol. 2010;11:R57. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 36. Li H, Handsaker B, Wysoker A et al. . The Sequence Alignment Map format and SAMtools. Bioinformatics. 2009;25:2078–9. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 37. Otto TD, Dillon GP, Degrave WS, et al. . RATT: Rapid Annotation Transfer Tool. Nucleic Acids Res. 2011;39:e57. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 38. Kurtz S, Phillippy A, Delcher AL, et al. . Versatile and open software for comparing large genomes. Genome Biol. 2004;5:R12. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 39. Waters LS, Storz G. Regulatory RNAs in bacteria. Cell. 2009;136:615–28. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 40. Bouvier M, Sharma CM, Mika F et al. . Small RNA binding to 5’ mRNA coding region inhibits translational initiation. Mol Cell. 2008;32:827–37. [DOI] [PubMed] [Google Scholar]
  • 41. Chao Y, Papenfort K, Reinhardt, et al. . An atlas of Hfq-bound transcripts reveals 3’UTRs as a genomic reservoir of regulatory small RNAs. EMBO j. 2012;31:4005–19. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 42. Forster SC, Finkel AM, Gould JA et al. . RNA-eXpress annotates novel transcript features in RNA-seq data. Bioinformatics. 2013;29:810–2. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 43. Hochschild A. Gene-specific regulation by a transcript cleavage factor: facilitating promoter escape. J Bacteriol. 2007;189:8769–71. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 44. Kingsford CL, Ayanbule K, Salzberg SL. Rapid, accurate, computational discovery of Rho-independent transcription terminators illuminates their relationship to DNA uptake. Genome Biol. 2007;8:R22. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 45. Bailey TL, Williams N, Misleh C, et al. . MEME: discovering and analyzing DNA and protein sequence motifs. Nucleic Acids Res. 2006;34:W369–73. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 46. Frith MC, Saunders NFW, Kobe B et al. . Discovering sequence motifs with arbitrary insertions and deletions. PLoS Comput Biol. 2008;4:e1000071. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 47. Holmqvist E, Wright PR, Li L et al. . Global RNA recognition patterns of post-transcriptional regulators Hfq and CsrA revealed by UV crosslinking in vivo. EMBO J. 2016;35:991–1011. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 48. Miyakoshi M, Chao Y, Vogel J. Regulatory small RNAs from the 3’regions of bacterial mRNAs. Curr Opin Microbiol. 2015;24:132–9. [DOI] [PubMed] [Google Scholar]
  • 49. Smirnov A, Förstner KU, Holmqvist E et al. . Grad-seq guides the discovery of ProQ as a major small RNA-binding protein. Proc Natl Acad Sci USA. 2016;113:11591–6. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 50. Camacho C, Coulouris G, Avagyan V et al. . BLAST+: architecture and applications. BMC Bioinformatics. 2009;10:421. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 51. Li L, Huang D, Cheung MK et al. . BSRD: a repository for bacterial small regulatory RNA. Nucleic Acids Res. 2013;41:D233–8. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 52. Lorenz R, Bernhart SH, Höner Zu Siederdissen C et al. . ViennaRNA Package 2.0. Algorithm Mol Biol. 2011;6:26. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 53. Tafer H, Hofacker IL. RNAplex: a fast tool for RNA-RNA interaction search. Bioinformatics. 2008;24:2657–63. [DOI] [PubMed] [Google Scholar]
  • 54. Mückstein U, Tafer H, Hackermüller J, et al. . Thermodynamics of RNA-RNA binding. Bioinformatics. 2006;22:1177–82. [DOI] [PubMed] [Google Scholar]
  • 55. Mann M, Wright PR, Backofen R. IntaRNA 2.0: enhanced and customizable prediction of RNA-RNA interactions. Nucleic Acids Res. 2017;45:W435–9. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 56. Storz G, Wolf YI, Ramamurthi KS. Small proteins can no longer be ignored. Annu Rev Biochem. 2014;83:753–77. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 57. The Gene Ontology Consortium. Gene Ontology Consortium: going forward. Nucleic Acids Res. 2015;43:D1049–56. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 58. Magrane M, Uniprot Consortium. UniProt Knowledgebase: a hub of integrated protein data. Database. 2011;p. bar009. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 59. Yu NY, Wagner JR, Laird MR, et al. . PSORTb 3.0: improved protein subcellular localization prediction with refined localization subcategories and predictive capabilities for all prokaryotes. Bioinformatics. 2010;26:1608–15. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 60. Szklarczyk D, Franceschini A, Wyder S et al. . STRING v10: protein-protein interaction networks, integrated over the tree of life. Nucleic Acids Res. 2015;43:D447–52. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 61. Kim S, Shin SY, Lee IH et al. . PIE: an online prediction system for protein-protein interactions from text. Nucleic Acids Res. 2008;36:W411–5. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 62. Hoffmann S, Otto C, Doose G et al. . A multi-split mapping algorithm for circular RNA, splicing, trans-splicing and fusion detection. Genome Biol. 2014;15:R34. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 63. Sander JD, Joung JK. CRISPR-Cas systems for editing, regulating and targeting genomes. Nat Biotechnol. 2014;32:347–55. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 64. Bland C, Ramsey TL, Sabree F, et al. . CRISPR recognition tool (CRT): a tool for automatic detection of clustered regularly interspaced palindromic repeats. BMC Bioinformatics. 2007;8:209. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 65. Nawrocki EP, Burge SW, Bateman A et al. . Rfam 12.0: updates to the RNA families database. Nucleic Acids Res. 2014;43:D130–7. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 66. Nawrocki EP, Eddy SR. Infernal 1.1: 100-fold faster RNA homology searches. Bioinformatics. 2013;29:2933–5. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 67. Salgado H, Peralta-Gil M, Gama-Castro S, et al. . RegulonDB v8.0: omics data sets, evolutionary conservation, regulatory phrases, cross-validated gold standards and more. Nucleic Acids Res. 2013;41:D203–13. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 68. Mendoza-Vargas A, Olvera L, Olvera M et al. . Genome-wide identification of transcription start sites, promoters and transcription factor binding sites in. E. coli PLoS ONE 2009-10-19;4(10):e7526. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 69. Dingemans J, Monsieurs P, Yu SH et al. . Effect of shear stress on Pseudomonas aeruginosa isolated from the cystic fibrosis lung. mBio. 2016;7:e00813–16. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 70. Remes B, Rische-Grahl T, Müller T et al. . An RpoHI-dependent response promotes outgrowth after extended stationary phase in the alphaproteobacterium Rhodobacter sphaeroides. J Bacteriol. 2017;199. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 71. Yu SH, Vogel J, Förstner K. Supporting data for ANNOgesic: a Swiss army knife for the RNA-seq based annotation of bacterial/archaeal genomes. GigaScience Database. 2018; 10.5524/100481. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 72. Yu SH, Vogel J, Förstner K. ANNOgesic - a Swiss army knife for the RNA-seq based annotation of bacterial/archaeal genomes. CodeOcean. 2018;https://doi.org/10.24433/CO.6eae18de-4c12-4245-86fc-e9a447d22c68. [DOI] [PMC free article] [PubMed] [Google Scholar]

Associated Data

This section collects any data citations, data availability statements, or supplementary materials included in this article.

Supplementary Materials

GIGA-D-18-00029-Original_Submission.pdf
GIGA-D-18-00029_Revision_1.pdf
GIGA-D-18-00029_Revision_2.pdf
Response_to_Reviewer_Comments_Original_Submission.pdf
Response_to_Reviewer_Comments_Revision1.pdf
Reviewer_1_Report_(Original_Submission) -- A. Rebecca Wattam

02-26-2018 Reviewed

Reviewer_2_Report_(Original_Submission).pdf -- Raquel Tobes, Ph.D

04-14-2018 Reviewed

Reviewer_3_Report_(Original_Submission).pdf -- Roy Chaudhuri

07-17-2018 Reviewed

Reviewer_3_Report_Revision_1.pdf -- Roy Chaudhuri

07-06-2018 Reviewed

Supplement_Files.zip

Articles from GigaScience are provided here courtesy of Oxford University Press

RESOURCES