Skip to main content

COMAN: a web server for comprehensive metatranscriptomics analysis

Abstract

Background

Microbiota-oriented studies based on metagenomic or metatranscriptomic sequencing have revolutionised our understanding on microbial ecology and the roles of both clinical and environmental microbes. The analysis of massive metatranscriptomic data requires extensive computational resources, a collection of bioinformatics tools and expertise in programming.

Results

We developed COMAN (Comprehensive Metatranscriptomics Analysis), a web-based tool dedicated to automatically and comprehensively analysing metatranscriptomic data. COMAN pipeline includes quality control of raw reads, removal of reads derived from non-coding RNA, followed by functional annotation, comparative statistical analysis, pathway enrichment analysis, co-expression network analysis and high-quality visualisation. The essential data generated by COMAN are also provided in tabular format for additional analysis and integration with other software. The web server has an easy-to-use interface and detailed instructions, and is freely available at http://sbb.hku.hk/COMAN/

Conclusions

COMAN is an integrated web server dedicated to comprehensive functional analysis of metatranscriptomic data, translating massive amount of reads to data tables and high-standard figures. It is expected to facilitate the researchers with less expertise in bioinformatics in answering microbiota-related biological questions and to increase the accessibility and interpretation of microbiota RNA-Seq data.

Background

In the era of next-generation sequencing (NGS), microbiome-oriented studies have recently been the “hot spot” and have deepened our understanding on the crucial roles of both clinical and environmental microbes. The field of shotgun metagenomics investigating the genetic potential of microbiota has blossomed out, shedding light on microbial ecology, evolution and disease biology. Metatranscriptomics investigates the totality of the expressed genes in a microbial community under particular conditions. This RNA-based profiling of microbial community structure and function can reflect the actual expressed activity of involved microbiota unseen by metagenomics, and has been applied mainly to environmental microbiota during early stage [1, 2]. The subsequent application of metatranscriptomics to human gut microbiota [3, 4] has revealed actively transcribed core modules, inter-subject and temporal gene expression variations. More importantly, metatranscriptomics can also unveil the microbial responses to altered environmental conditions (e.g. disease versus health) or other external stimuli. Dietary [5] and xenobiotic treatments [6] have been found to alter significantly gut microbial gene expression profiles, while health- and disease-associated oral microbiota communities displayed defined metabolic differences [7].

The use of NGS in metatranscriptomics generates large datasets with high degree of complexity, which needs to be analysed effectively to translate the non-interpretable raw sequencing reads to biological insights, in the format of data tables and figures. Although a few relevant methods or pipelines for processing RNA-Seq data have been proposed [810], the whole analysis process for such high-throughput data typically involves many individual steps, the installation and execution of a wide range of software tools, extensive computational resources and expertise in programming and NGS bioinformatics data analysis. Particularly, Leimena et al. [9] described in detail a pipeline, or guidelines, for analysing metatranscriptomic Illumina RNA-seq data, but did not implement it as a software tool or web-based server. MetaTrans [11] and SAMSA [12] are the tools recently developed specifically for metatranscriptomics, but they require proper local setup on a powerful computer cluster or offer limited functional analysis. Therefore, even though metatranscriptomic data are now routinely generated, it is challenging for wet-lab researchers to analyse them and generate biological relevant information. Despite that web-based servers such as MG-RAST [13] and EBI Metagenomics [14] can be also adopted for metatranscriptomics, they were originally designed to process and annotate metagenomic data with limited functionality in uncovering and elucidating the active microbial functions and responses to external stimuli hidden in metatranscriptomics.

Here we present COMAN, a web-based application for functional characterisation and comprehensive analysis of high-throughput metatranscriptomic data. COMAN processes uploaded raw reads automatically to ultimately achieve functional assignments, which are then used to perform comparative statistical analysis, pathway enrichment and co-expression network analysis, to relate taxonomy with functional variations and to visualize the results. With an easy-to-use interface and extensive instructions, COMAN can be run by experimentalists without programming experience and without the hassle of changing tools or working environments for answering their biologically relevant questions. However, since the essential data are also provided in tabular format, users with bioinformatics expertise may perform additional analysis and integration with other software.

Implementation

COMAN accepts as input the Illumina paired-end sequencing reads in FASTQ format and a metadata file specifying the sample conditions for comparative statistical analysis. A sample input dataset is offered to guide users on data formatting requirements (by clicking the “SampleData” button in the homepage). It is optional to upload a file containing the metagenomic taxonomic abundance profiles, which will only be used for “transcription activation analysis” (as described below). All uploaded data and results generated by COMAN are restricted to the user who initiated the job. A comprehensive guidance on COMAN usage can be found in the “Instructions” section of the server homepage.

The whole COMAN metatranscriptome data analysis pipeline (Fig. 1) mainly involves quality control, removal of reads derived from non-coding RNAs, functional annotation, comparative statistical analysis, taxonomy-associated functional analysis and co-expression network analysis. Details on key steps are shown below:

Fig. 1
figure 1

The metatranscriptome analysis pipeline in COMAN. The example output figures from the analysis of a gut microbiome dataset are shown. Upper left: functional profiling; upper right: taxonomic contribution analysis (complete linkage method for clustering algorithm and Euclidean distance for dissimilarity metric); lower left: multi-dimensional scaling to illustrate sample clustering; lower right: co-expression network analysis with different inferred communities (for clarity purpose, the communities with fewer than 3 elements are merged together and not highlighted here)

Quality control and removal of non-coding RNA

The uploaded NGS reads are subject to an initial quality control step to remove the adapter regions and low quality reads following a previously described approach [15]. Afterwards, all the QC-passed reads are mapped, using BLASTN, to an in-house non-coding RNA database (see Results for details and evaluation) to filter out the reads derived from non-coding RNAs, including ribosomal RNA and tRNA. The reads with best BLAST hits at e-value < 10−5 are excluded from downstream analysis.

Mapping to reference genomes

In this step, all the high quality reads after depletion of non-coding RNA are further mapped to a reference genome database at 1e-5 cutoff, which includes more than 2700 NCBI complete microbial genomes (accessed at ftp://ftp.ncbi.nlm.nih.gov/genomes/archive/old_refseq/Bacteria/all.faa.tar.gz). We used a much faster and highly sensitive tool named DIAMOND [16] within the COMAN pipeline, since using BLASTX to perform this task is too time-consuming and not practically feasible, especially for a web-based application.

Functional annotation of genes and reads

Functional annotations of those reference genomes have been pre-prepared at the COMAN backend. This includes commonly used annotation systems: Clusters of Orthologous Groups (COG) [17] and KEGG Ortholog groups (KO) [18]. The annotation to COG was conducted using RPS-BLAST against the CDD database (v.3.10) at 1e-5 cutoff, whereas the KO annotation was through the combinatorial use of DIAMOND and KOBAS 2.0 annotate program [19]. In addition, we used PRIAM (with default parameters) [20] to annotate the genes to enzymes (Enzyme Commission numbers) (ECs) that are further used to achieve the profiling of MetaCyc pathways [21].

Comparative statistical analysis

Based on the mapping of reads to reference genomes and the functional annotation results, COMAN performs functional profiling and calculates the relative abundance for each functional group and enzyme, as well as for a higher hierarchy level in the annotation system. This high-level profiling includes COG categories, KEGG pathways, KEGG pathway classes, KEGG modules, and various levels of MetaCyc pathways.

The clustering of all samples using multidimensional scaling (MDS) is incorporated within the pipeline. Once the functional profiling based on COG and KO is completed, the metadata file will be used to conduct differential expression (DE) analysis (Wilcoxon rank sum test, with the default cutoff of FDR-corrected p-value being 0.10), in order to characterise the potential functional changes between two different conditions.

Researchers are often highly interested in the associations between pathway variations and biological phenotypes observed. To facilitate such process, we integrate pathway inference and analysis based on KEGG and MetaCyc into the COMAN pipeline. Despite certain overlap and differences [22], they are both commonly used pathway systems during genomic analysis and metabolic reconstruction, and users of COMAN will have access to results derived from both databases. Most importantly, COMAN uses MinPath [23] to infer the pathways represented in the submitted microbial communities, based on functional annotations of genes and the relationship between pathways and functional groups (KO for KEGG; EC for MetaCyc). Compared with the naive one-hit-match mapping approach that may inflate the number of inferred pathways leading to overestimation of functional diversity, MinPath eliminates some spurious pathways and achieves a more trustworthy inference of biological pathways present in the samples [23].

Afterwards, COMAN incorporates GAGE [24] to infer the significantly enriched or depleted pathways when comparing two conditions. Users may apply a suitable threshold of FDR-corrected p-values to identify such pathways that display coordinated differential expression over the whole pathway and that can be associated with the biological phenotypes. This pathway enrichment analysis is applied to KEGG pathways, KEGG modules and MetaCyc pathways.

Functional profiling, differential expression and pathway enrichment analysis elucidate the functional states and dynamic changes or responses of the involved microbiota community. It is also useful to relate the observed functional variations with particular taxa [25]. For this purpose, COMAN performs a taxonomic contribution analysis to identify which microbial phylum is mostly responsible for community-level expression variation, for each of the most varied functional groups (Fig. 1). These “most varied functional groups” refer to either significantly differentially expressed ones based on user-specified FDR-corrected p-value, or the ones with highest fold-change (up- 50 and down-regulated 50 groups) when the former is not available. Last but not least, COMAN incorporates a taxonomic distribution analysis, where the expression distributions of each functional group among different phyla at both conditions are calculated.

Transcription activation analysis

If the user has the taxonomic abundance profiles across all samples generated by metagenomic sequencing and analysis, this file (phylum-level) can be uploaded to COMAN at the data uploading process. Afterwards, COMAN normalises the gene expressions using the taxonomic abundances, followed by comparison and visualisation of the normalised expression levels in two conditions. This further elucidates whether the observed expression variations of certain genes are derived from varied transcription levels (transcriptional activation or repression) or simply caused by bacterial taxonomic composition differences.

Co-expression network analysis

In co-expression network, genes having similar or related functions tend to possess similar expression profiles and thus tend to be clustered together [26, 27]. COMAN calculates the pairwise correlations (Spear correlation) for the “most varied functional groups” aforementioned, based on their expression profiles among different samples in one condition, and generates a co-expression network accordingly. Afterwards, the random walk algorithm is used to find densely connected sub-networks, or communities within the network (Fig. 1). The elements within the same community represent concordant behaviours, such as similar responses to a particular stimulus, and thus the similar or closely related functions.

The results from COMAN co-expression analysis include TAB-delimited data files presenting the involved functional groups and their topological properties and belonged communities, as well as high-quality figures for network visualisation with deduced communities (Fig. 1). Moreover, since such network typically contains extensive information, a web-based interactive network is provided in the result page for deeper inspection. For clarity purposes, all detected communities with fewer than 3 elements are merged into one single residual module. Users may also investigate the “hub nodes” in the resulting network, which represent genes or functional groups with extremely high connectivity.

Despite that only the “most varied functional groups” are involved in COMAN, users may use the abundance profiles for all functional groups or any subset of interest (COGs, KOs, or ECs) to construct a global co-expression network and perform network topological analysis. Note that to perform a meaningful co-expression network analysis using COMAN, the minimal number of samples within one condition has to be greater than four. However, we recommend the sample size to be larger than eight in order to generate findings of more biological relevance with lower false positives.

Profiling of Biosynthetic Gene Clusters for analysis of microbial secondary metabolites

Biosynthetic gene clusters (BGCs) are physically clustered gene sets responsible for the synthesis of microbial secondary metabolites, whose importance and widespread distribution in the human microbiome have been demonstrated before [28]. Despite the greater understanding of different microbiota in varying environments, there is still paucity of characterised metabolites that are synthesized by the microbial community and that may contribute to the differential phenotypes [15]. Here we plugin antiSMASH 3.0 [29] for BGC annotation into the COMAN pipeline, to facilitate the characterisation and comparison of secondary metabolite biosynthesis among different conditions. Using our pre-prepared identification of BGCs from the NCBI reference genomes, the BGCs and their abundances in each submitted sample can be calculated following similar rules as Donia et al [28]: 50 % of genes (after excluding non-biosynthetic ones) in each BGC need to be covered by reads; the abundance score of this identified BGC is defined by taking the average abundance of these genes. Further, the abundances of BGCs producing different types of secondary metabolites (BGC types, as defined by antiSMASH) are calculated, followed by a comparative statistical analysis (Wilcoxon rank sum test) to identify differentially abundant BGC types. This reveals the active production capability of different types of secondary metabolites by the involved microbiota. A bar chart illustrating the relative proportion of different types is provided as well. Note that this BGC-related analysis module in COMAN reflects the transcriptionally active BGCs in the microbial community.

Results visualisation and access

COMAN produces a collection of easy-to-interpret figures upon job termination. The example output of a complete dataset derived from a human gut microbiome project is available on the server (the “Example Data” section of the server homepage). The essential data in tabular format (“TAB” delimited file) are provided, therefore the user may use them to perform additional analyses, which include the integration with other tools as well as more sophisticated analyses for advanced users. For relatively basic figures such as bar charts, they can make custom modifications of figures using their preferred programs. For co-expression network visualisation, users may choose CytoScape with a graphical user interface or use the R script provided (Additional file 1) to apply different filtering and layout parameters to the network. Moreover, COMAN keeps the raw sequence mapping files in BLAST m8 format that includes the details of sequence alignment (e.g. identity, alignment position, e-value). A detailed documentation called “README.txt” describing each output file is included for every completed job to help users interpret the results.

All results generated by COMAN are compressed to simplify data download. Since the sequence mapping results are high data volume and take considerably more time to download, COMAN separates such files with those generated by functional analysis for the convenience of users.

Results and discussion

Construction and evaluation of non-coding RNA database

The removal of reads derived from non-coding RNA can avoid the potential bias during downstream analysis, but would normally take a few days for all sequenced samples and even up to one month for larger datasets with deep sequencing. Since the purpose here is only to identify and remove those reads, rather than to determine their taxonomic origins, there would be great extent of redundancy within the non-coding RNA database such as SILVA [30]. To reduce the computational burden and accelerate our pipeline, we constructed and evaluated an in-house non-coding RNA database, which is a random 10 % subset of the combination of 1) NCBI bacterial reference genomes non-coding RNAs (accessed at ftp://ftp.ncbi.nlm.nih.gov/genomes/archive/old_refseq/Bacteria/all.frn.tar.gz); and (2) eukaryotic ribosomal DNA (both large and small subunits) within SILVA (See Additional file 2 for details in construction and evaluation of the database).

We compared the performance of different random 10 % and 5 % subsets (5 % NCBI + 5 % SILVA), as well as the full combined database without taking subsets. It can be seen from Fig. 2 that while the 10 % subsets showed rather high accuracy, sensitivity and stability, the performance of random 5 % subsets was not very stable, with one of them having sensitivity even below 90 %. Being much less redundant, the final 10 % combined database reduces the mapping time remarkably (~6 folds) while remaining nearly the same sensitivity as compared to the full database. Using this in-house non-coding RNA database, the reads with best BLAST hits at e-value < 10−5 are excluded from downstream analysis.

Fig. 2
figure 2

Performance evaluation of subsets of the combined database used in COMAN. The combined database was constructed by merging the NCBI bacterial reference genomes non-coding RNAs with eukaryotic ribosomal DNA (both large and small subunits) deposited in the SILVA database. Different subsets of random 10 % and 5 % of the full combined database (indicated by x-axis) were taken and their performance was compared to the BLASTN mapping results from using the full version. For each subset, the “Relative Accuracy” is defined as the number of commonly identified reads between the subset and the full database, divided by the total number of reads identified only by using the subset for mapping. In comparison, the “Relative Sensitivity” is defined as the number of commonly identified reads between the subset and the full database, divided by the total number of reads identified by using the full database

Case study

For illustration, we performed an analysis of a complete dataset from a human gut microbiota project [5] and the results preview can be accessed via the “Example Data” page. The MDS results generated by COMAN (Additional file 3) shows that samples from two different conditions (“control diet” and “plant-based diet”) separated clearly, indicating the functional alterations of human gut microbiome by plant-based diet. The subsequent taxonomic contribution analysis suggests that Firmicutes, Proteobacteria, Actinobacteria and Bacteroidetes were the main contributors of community-level variations for the most varied functional groups. Moreover, Firmicutes was found to contribute predominately to the up-regulated KEGG orthologous groups. Similar analysis with more focused discussion on the results has been performed in our previous attempt to understand the diet-gut metagenome interactions at a molecular level [25].

Computational time and throughput

After optimising the sequence-mapping step, the whole COMAN analysis should be completed within a few days (typically 1-2 days). Using our example dataset that includes 18 samples with an average of around 22M reads per sample, the time elapsed was approximately 2.5 days. In relation to the functional analysis part, it was completed in less than 10 min. COMAN has the capacity to handle multiple jobs simultaneously and the time needed depends on the sequencing depth, the number of samples and the server workload. Users should expect that running 5 jobs in parallel with each job containing 10 samples with ~20M reads will require approximately one week to be completed. The users may check the results at a later time with the provided job ID, bookmarked pages or get notified by email upon job termination (given that an email address is provided).

Other highlights

By using a large amount of complete microbial genomes, COMAN is able to perform functional annotation for more than one system, including the widely accepted KEGG, COG and MetaCyc, as well as a more specialised annotation for secondary metabolite biosynthesis - namely biosynthetic gene clusters (BGCs). Therefore, in addition to the comparative analysis aimed to shed lights on the links between functional variations and biological phenotypes, COMAN also serves as a versatile functional annotation tool that provides the fundamental data tables essential for in-depth analysis. More experienced users may use such results generated by COMAN with multiple functional annotation and pathway systems, directly or with slight data rearrangements, as the input of other specialised NGS data analysis programs such as LefSe [31].

Conclusion

Here, we developed COMAN (Comprehensive Metatranscriptomics Analysis), which serves as a platform to translate the non-interpretable raw sequencing reads to data tables and high-standard figures that can be easily handled and further analysed. Although related theoretical methods or tools have been reported before, COMAN is an integrated web server dedicated to comprehensive functional analysis of metatranscriptomic data. It is easy-to-use and relatively fast, with extensive instructions on input data format, server navigation and results interpretation. The output includes high-quality figures in both PNG and PDF formats, as well as the essential data in tabular format. Therefore, COMAN is expected to facilitate the researchers, who may lack the expertise or computational resources, to analyse microbiota RNA-Seq data towards tackling their biological questions of interest. Advanced users with bioinformatics expertise may perform additional analysis and integration with other software by utilising the essential tabular data COMAN generates. With a wide range of target audience including microbiologists, environmental biologists and clinicians, we believe COMAN will benefit the community remarkably in revealing the importance of both environmental and clinical microbiota. Considering the availability of powerful computational resources, the current pipeline is only run on our server in a web-based manner. However, making COMAN pipeline as a separate software package that can be setup locally and run in a fully customised way is in our plans. The COMAN server will be actively and continuously updated to incorporate more annotation systems and analysis modules (e.g. taxonomy-related analysis at high-resolution) in the future.

Availability and requirements

  • Project name: COMAN

  • Project home page: http://sbb.hku.hk/COMAN

  • Operating system(s): Platform-independent

  • Programming language: Python, R

  • License: This server is free to all users without login requirement

Abbreviations

BGC, Biosynthetic gene clusters; COG, Clusters of Orthologous Groups; DE, Differential Expression; EC, Enzyme Commission numbers; KO, KEGG Ortholog groups

References

  1. Frias-Lopez J, Shi Y, Tyson GW, Coleman ML, Schuster SC, Chisholm SW, Delong EF. Microbial community gene expression in ocean surface waters. Proc Natl Acad Sci U S A. 2008;105(10):3805–10.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  2. Tveit AT, Urich T, Svenning MM. Metatranscriptomic analysis of arctic peat soil microbiota. Appl Environ Microbiol. 2014;80(18):5761–72.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  3. Booijink CC, Boekhorst J, Zoetendal EG, Smidt H, Kleerebezem M, de Vos WM. Metatranscriptome analysis of the human fecal microbiota reveals subject-specific expression profiles, with genes encoding proteins involved in carbohydrate metabolism being dominantly expressed. Appl Environ Microbiol. 2010;76(16):5533–40.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  4. Turnbaugh PJ, Quince C, Faith JJ, McHardy AC, Yatsunenko T, Niazi F, Affourtit J, Egholm M, Henrissat B, Knight R, et al. Organismal, genetic, and transcriptional variation in the deeply sequenced gut microbiomes of identical twins. Proc Natl Acad Sci U S A. 2010;107(16):7503–8.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  5. David LA, Maurice CF, Carmody RN, Gootenberg DB, Button JE, Wolfe BE, Ling AV, Devlin AS, Varma Y, Fischbach MA, et al. Diet rapidly and reproducibly alters the human gut microbiome. Nature. 2014;505(7484):559–63.

    Article  CAS  PubMed  Google Scholar 

  6. Maurice CF, Haiser HJ, Turnbaugh PJ. Xenobiotics shape the physiology and gene expression of the active human gut microbiome. Cell. 2013;152(1-2):39–50.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  7. Jorth P, Turner KH, Gumus P, Nizam N, Buduneli N, Whiteley M. Metatranscriptomics of the human oral microbiome during health and disease. MBio. 2014;5(2):e01012–01014.

    Article  PubMed  PubMed Central  Google Scholar 

  8. Goncalves A, Tikhonov A, Brazma A, Kapushesky M. A pipeline for RNA-seq data processing and quality assessment. Bioinformatics. 2011;27(6):867–9.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  9. Leimena MM, Ramiro-Garcia J, Davids M, van den Bogert B, Smidt H, Smid EJ, Boekhorst J, Zoetendal EG, Schaap PJ, Kleerebezem M. A comprehensive metatranscriptome analysis pipeline and its validation using human small intestine microbiota datasets. BMC Genomics. 2013;14:530.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  10. Friedman BA, Maniatis T. ExpressionPlot: a web-based framework for analysis of RNA-Seq and microarray gene expression data. Genome Biol. 2011;12(7):R69.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  11. Martinez X, Pozuelo M, Pascal V, Campos D, Gut I, Gut M, Azpiroz F, Guarner F, Manichanh C. MetaTrans: an open-source pipeline for metatranscriptomics. Sci Rep. 2016;6:26447.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  12. Westreich ST, Korf I, Mills DA, Lemay DG: SAMSA: A comprehensive metatranscriptome analysis pipeline. bioRxiv 2016.

  13. Meyer F, Paarmann D, D'Souza M, Olson R, Glass EM, Kubal M, Paczian T, Rodriguez A, Stevens R, Wilke A, et al. The metagenomics RAST server - a public resource for the automatic phylogenetic and functional analysis of metagenomes. BMC Bioinformatics. 2008;9:386.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  14. Hunter S, Corbett M, Denise H, Fraser M, Gonzalez-Beltran A, Hunter C, Jones P, Leinonen R, McAnulla C, Maguire E, et al. EBI metagenomics--a new resource for the analysis and archiving of metagenomic data. Nucleic Acids Res. 2014;42(Database issue):D600–606.

    Article  CAS  PubMed  Google Scholar 

  15. Li J, Sung CY, Lee N, Ni Y, Pihlajamaki J, Panagiotou G, El-Nezami H. Probiotics modulated gut microbiota suppresses hepatocellular carcinoma growth in mice. Proc Natl Acad Sci U S A. 2016;113(9):E1306–1315.

    Article  CAS  PubMed  Google Scholar 

  16. Buchfink B, Xie C, Huson DH. Fast and sensitive protein alignment using DIAMOND. Nat Methods. 2015;12(1):59–60.

    Article  CAS  PubMed  Google Scholar 

  17. Tatusov RL, Koonin EV, Lipman DJ. A genomic perspective on protein families. Science. 1997;278(5338):631–7.

    Article  CAS  PubMed  Google Scholar 

  18. Kanehisa M, Goto S. KEGG: kyoto encyclopedia of genes and genomes. Nucleic Acids Res. 2000;28(1):27–30.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  19. Xie C, Mao X, Huang J, Ding Y, Wu J, Dong S, Kong L, Gao G, Li CY, Wei L: KOBAS 2.0: a web server for annotation and identification of enriched pathways and diseases. Nucleic Acids Res 2011, 39(Web Server issue):W316-322.

  20. Claudel-Renard C, Chevalet C, Faraut T, Kahn D. Enzyme-specific profiles for genome annotation: PRIAM. Nucleic Acids Res. 2003;31(22):6633–9.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  21. Caspi R, Altman T, Billington R, Dreher K, Foerster H, Fulcher CA, Holland TA, Keseler IM, Kothari A, Kubo A, et al. The MetaCyc database of metabolic pathways and enzymes and the BioCyc collection of Pathway/Genome Databases. Nucleic Acids Res. 2014;42(Database issue):D459–471.

    Article  CAS  PubMed  Google Scholar 

  22. Altman T, Travers M, Kothari A, Caspi R, Karp PD. A systematic comparison of the MetaCyc and KEGG pathway databases. BMC Bioinformatics. 2013;14:112.

    Article  PubMed  PubMed Central  Google Scholar 

  23. Ye Y, Doak TG. A parsimony approach to biological pathway reconstruction/inference for genomes and metagenomes. PLoS Comput Biol. 2009;5(8):e1000465.

    Article  PubMed  PubMed Central  Google Scholar 

  24. Luo W, Friedman MS, Shedden K, Hankenson KD, Woolf PJ. GAGE: generally applicable gene set enrichment for pathway analysis. BMC Bioinformatics. 2009;10:161.

    Article  PubMed  PubMed Central  Google Scholar 

  25. Ni Y, Li J, Panagiotou G. A Molecular-Level Landscape of Diet-Gut Microbiome Interactions: Toward Dietary Interventions Targeting Bacterial Genes. MBio. 2015;6(6):e01263–15.

    Article  PubMed  PubMed Central  Google Scholar 

  26. Ruan J, Dean AK, Zhang W. A general co-expression network-based approach to gene expression analysis: comparison and applications. BMC Syst Biol. 2010;4:8.

    Article  PubMed  PubMed Central  Google Scholar 

  27. Serin EA, Nijveen H, Hilhorst HW, Ligterink W. Learning from Co-expression Networks: Possibilities and Challenges. Front Plant Sci. 2016;7:444.

    Article  PubMed  PubMed Central  Google Scholar 

  28. Donia MS, Cimermancic P, Schulze CJ, Wieland Brown LC, Martin J, Mitreva M, Clardy J, Linington RG, Fischbach MA. A systematic analysis of biosynthetic gene clusters in the human microbiome reveals a common family of antibiotics. Cell. 2014;158(6):1402–14.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  29. Weber T, Blin K, Duddela S, Krug D, Kim HU, Bruccoleri R, Lee SY, Fischbach MA, Muller R, Wohlleben W, et al. antiSMASH 3.0-a comprehensive resource for the genome mining of biosynthetic gene clusters. Nucleic Acids Res. 2015;43(W1):W237–243.

    Article  PubMed  PubMed Central  Google Scholar 

  30. Quast C, Pruesse E, Yilmaz P, Gerken J, Schweer T, Yarza P, Peplies J, Glockner FO. The SILVA ribosomal RNA gene database project: improved data processing and web-based tools. Nucleic Acids Res. 2013;41(Database issue):D590–596.

    Article  CAS  PubMed  Google Scholar 

  31. Segata N, Izard J, Waldron L, Gevers D, Miropolsky L, Garrett WS, Huttenhower C. Metagenomic biomarker discovery and explanation. Genome Biol. 2011;12(6):R60.

    Article  PubMed  PubMed Central  Google Scholar 

Download references

Acknowledgements

GP and JL would like to thank the Strategic Research Theme of Genomics of the University of Hong Kong for their support.

Author’s contributions

YN, JL, and GP designed the study and prepared the manuscript; YN and JL performed computational analyses; YN developed and designed the web server. All authors read and approved the final manuscript.

Competing interests

All the authors declare that they have no conflict of interests.

Consent for publication

Not applicable.

Ethics approval and consent to participate

Not applicable.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Gianni Panagiotou.

Additional files

Additional file 1:

The R script to visualise the co-expression network. The input file is generated by COMAN co-expression analysis. (R 8 kb)

Additional file 2:

Supplementary results detailing the process of constructing and evaluating the non-coding RNA database used in COMAN. (DOC 345 kb)

Additional file 3:

Clustering of all samples from the example data using Multidimensional Scaling based on the abundances of all COG groups. Dark blue: control or baseline diet; orange: after plant-based diet. (PDF 5 kb)

Rights and permissions

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

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Ni, Y., Li, J. & Panagiotou, G. COMAN: a web server for comprehensive metatranscriptomics analysis. BMC Genomics 17, 622 (2016). https://0-doi-org.brum.beds.ac.uk/10.1186/s12864-016-2964-z

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://0-doi-org.brum.beds.ac.uk/10.1186/s12864-016-2964-z

Keywords