Skip to main content
Computational and Structural Biotechnology Journal logoLink to Computational and Structural Biotechnology Journal
. 2016 Dec 5;15:48–55. doi: 10.1016/j.csbj.2016.11.005

Bioinformatics strategies for taxonomy independent binning and visualization of sequences in shotgun metagenomics

Karel Sedlar 1,, Kristyna Kupkova 1, Ivo Provaznik 1
PMCID: PMC5148923  PMID: 27980708

Abstract

One of main steps in a study of microbial communities is resolving their composition, diversity and function. In the past, these issues were mostly addressed by the use of amplicon sequencing of a target gene because of reasonable price and easier computational postprocessing of the bioinformatic data. With the advancement of sequencing techniques, the main focus shifted to the whole metagenome shotgun sequencing, which allows much more detailed analysis of the metagenomic data, including reconstruction of novel microbial genomes and to gain knowledge about genetic potential and metabolic capacities of whole environments. On the other hand, the output of whole metagenomic shotgun sequencing is mixture of short DNA fragments belonging to various genomes, therefore this approach requires more sophisticated computational algorithms for clustering of related sequences, commonly referred to as sequence binning. There are currently two types of binning methods: taxonomy dependent and taxonomy independent. The first type classifies the DNA fragments by performing a standard homology inference against a reference database, while the latter performs the reference-free binning by applying clustering techniques on features extracted from the sequences. In this review, we describe the strategies within the second approach. Although these strategies do not require prior knowledge, they have higher demands on the length of sequences. Besides their basic principle, an overview of particular methods and tools is provided. Furthermore, the review covers the utilization of the methods in context with the length of sequences and discusses the needs for metagenomic data preprocessing in form of initial assembly prior to binning.

Keywords: Metagenomics, Taxonomy independent, Sequence binning, Genomic signature, Abundance, Visualization

1. Introduction

Direct sequencing of genomic material from an environment, commonly referred to as metagenomics, helped to provide a full insight into entire microbial communities that could not have been studied before for a majority of the organisms are uncultivable [1]. Nowadays, there are thousands of metagenomic projects compared with only few studies published in early 2000s [2], [3]. The aim of these projects is to explore microbiologically diverse environments such as soil [4], marine water [5], gut or other niches of human [6] or other higher eukaryotes. Each of these habitats is characterized by specific taxonomic composition of particular genomes and every genome by its specific composition of genes, forming the resulting metabolism [7]. Metagenomic research can therefore infer medically or industrially important knowledge by revealing hitherto undescribed genes responsible for antibiotic resistance or enzyme synthesis [8]. To further underline the importance of metagenomic research, it was estimated that the microbial cell population of human genome outnumbers the number of human own cells by 10 fold [9], leading to conclusion that the influence of microbiota on human health is far greater than it was expected. One of the basic problems in metagenomic studies remains in taxonomic classification of the sequences within the sample. This task is a challenging one since the volume of metagenomic data is rather large and therefore imposes high demands on bioinformatic tools for fast and effective data processing. Furthermore, there is no prior knowledge about the species richness of the sample which makes the classification process even more challenging. In metagenomics, the assignment of genomic fragments to the corresponding taxonomic group, e.g. species, genera or higher taxonomic groups, is commonly referred to as “binning” as each of the sequences is placed into an imaginary bin representing ideally only fragments belonging to this group. The outcome of the binning process can then be used not only for taxonomic diversity assessment, but also for facilitation of genome assembly, evaluation of gene association with different taxonomic groups or as the basis for following metatranscriptomics or metabolomics analyses leading to revelation of novel interactions [10], [11], [12], [13].

With regards to sequencing strategy, there are two main approaches to study microbiomes. The first strategy is based on amplicon sequencing of a target gene in the metagenome, while the second strategy uses the whole metagenome shotgun (WMS) sequencing [14]. Using specific primers, only phylogenetic marker genes or their parts are sequenced in the first approach. 16S rRNA [15] and internal transcribed spacer (ITS) [16] regions are the most commonly used for prokaryotic and fungal species respectively. Unfortunately, no additional information apart from species richness and abundance can be determined for all sequences represent the same genomic region. Nevertheless, thanks to comprehensive databases of marker genes, the binning process is relatively easy and reliable [17], which makes the amplicon sequencing data analysis a standard approach for the diversity investigation of metagenomes [18] and new techniques for community detection and visualization of microbiomes are still being developed [19]. The solution to the loss of information about metagenome is offered by utilization of the second approach using WMS sequencing. This strategy provides a deep insight into a metagenome, as every sequence represents a random part, including unknown genes, of a genome occurring in the metagenome [20]. On the other hand, the preprocessing of the WMS data can be a challenging task not only for much larger volume of data being processed, but also due to the lack of the reference whole genomic sequences within the available databases. These challenges make the binning process especially difficult. However, a competitive research in bioinformatics strives to solve these issues and therefore a majority of the newly developed algorithms is focused on WMS data processing.

The output of whole metagenome sequencing is formed by genomic fragments, about which there is no taxonomical information available. These fragments can be analogously associated with puzzle pieces belonging to different puzzle sets. Moreover, their length can differ depending on the used sequencing technology [21]. Current assembling technologies are still unable to assemble the short fragments into a whole genome sequences, and often fail at level of contigs [22]; therefore binning process, where fragments are divided into species or strain-level clusters, is essential for better reconstruction of novel microbial genomes to gain knowledge about genetic potential of whole metagenome. There are two different groups of strategies for WMS data binning. The taxonomy dependent, also referred to as supervised, methods rely on comparison of sequences against reference databases. Comparison can be performed (i) on the sequence level using aligning algorithms like BLAST [23], BLAT [24], Bowtie [25], BWA [26], (ii) on the model level of a known phylogenetic origin using Hidden Markov Models (HMM) and specific database such as Pfam [27] or (iii) on a sequence composition level using GC content, oligonucleotide patterns [28], etc. Although there is a wide range of such techniques, they suffer from two major issues. Firstly, the comparison part of the algorithm is time consuming; this especially applies to the aligning methods. Secondly, the reference databases containing whole genome sequences are far from complete. According to estimations the whole prokaryotes group consists of almost 108 separate genospecies [8] and while there is more than 3 million of 16S rRNA genes already sequenced, only around 6000 complete genomes are available up to date [29], [30]. Therefore, a great number of sequences can end up either unassigned or as false positive assignments. The accuracy prediction of the methods then relies on the required taxonomy level of assignment, where the probability of assignment to the correct group rises with the increasing taxonomical level. The second group of methods overcomes both of the mentioned disadvantages by using taxonomy independent also called unsupervised approach. These techniques are based on extraction of parameters specific for given taxon out of the raw sequencing reads or preassembled contigs. The obtained parameters are then directly compared and binned by use of suitable machine learning algorithms, without the need for any reference database.

Although an overall summary of all strategies for metagenomic shotgun data binning, as well as validation strategies for these techniques is summarized in review by Mande et al. [31], the list of described taxonomy independent strategies contains only five techniques. While in taxonomy dependent strategy research authors mainly work on improving the current techniques, the taxonomy independent strategy, which became the main focus of interest and has undergone great development especially over the last five years, expanded by a lot of new techniques. In this mini review, we update the list of taxonomy independent strategies by recently published techniques and provide their further division and description. On top of that, the future trends in the field are briefly discussed at the end of this review.

2. Taxonomy independent binning algorithms

Rapid development of taxonomy independent strategies for metagenomic data binning brings a wide range of new techniques, utilizing various machine learning, clustering and visualization algorithms. While these techniques usually differ in algorithm they use for binning, they share the strategy for extraction of features on which the binning is performed. There are two basic types of features used for classification, namely features based on sequence composition, and features based on contig coverage reflecting abundance of given taxa in a microbial sample. Considering these parameters, the existing techniques can be divided into three categories, as shown in Fig. 1, specifically: (i) sequence composition based methods, (ii) abundance based methods, and (iii) hybrid methods, which combine both, information regarding the sequence composition as well as taxa abundance.

Fig. 1.

Fig. 1

Schematic distribution of current taxonomy independent binning methods into three categories; the eye symbol highlights the methods that enable visualization of datasets.

2.1. Sequence composition based binning

The core idea of the methods in this section is based on an assumption that the genome composition is unique for each taxon, and therefore it is possible to bin the sequences purely by comparing their content. Since sequence composition is character based, it is essential to first transform it to a suitable numerical feature vector. The most commonly used features are so-called genomic signatures, which are normalized frequencies of k-mers of a particular size [32]. Typically, k is set to four, which results in high dimensional Euclidean space with 44 = 256 dimensions formed by frequencies of particular words four characters in length {AAAA, AAAC,..., TTTT}. Various strategies can reduce the dimensionality of the vector by different methods, for example to 136 dimensions, when accounting for reversed complements and palindromes [33]. Another parameter that is possible to use for sequence comparison is the guanine-cytosine (GC) content, since studies confirmed difference of GC content among unrelated populations [34]. The common workflow of binning strategies is shown in Fig. 2.

Fig. 2.

Fig. 2

Workflow of taxonomy independent binning strategies.

TETRA [35], a tool for statistical analysis and comparison of sequences based on tetranucleotide pattern frequencies, can be considered as a predecessor of modern binning methods. The computing capacity of the tool, however, does not meet the needs of current metagenomics and the tool is no longer available. One example of the current methods using composition based binning is LikelyBin [36], which utilizes the Markov Chain Monte Carlo approach for binning sequences based on k-mers of lengths between k = 2 and k = 5. Despite the fact that the method is fully automatic, its use is limited only on low complexity metagenomes (2–10 species), where the method reaches high accuracy given sufficient genomic divergence. Better result in terms of precision and accuracy were reached by use of the SCIMM [37] technique, which uses interpolated Markov models (IMM) on initial clusters for production of higher quality bins. Unfortunately, initial bins need to be formed before the application of IMM on the data. This can be done either by k-means clustering, which needs a predicted number of clusters as an input, or by running another binning algorithm, e.g. LikelyBin [36] or CompostBin [38]. Although SCIMM can improve the quality of clusters, the final results are highly dependent on this initial step. Also use of SCIMM is limited to lower complexity metagenomes, as both recall, and especially precision values are lower with increasing number of genomes presented within a sample.

Complex microbial samples can be analyzed by use of different forms of self-organizing maps (SOMs) [39], [40], [41], [42], [43]. A SOM is an artificial neural network proposed by Kohonen (1990) [44] for data clustering. Its properties are making it an ideal tool for clustering and visualization of high-dimensional data like genomic signatures by mapping them on a two-dimensional map. One form of SOM is batch-learning SOM (BLSOM) specifically modified for genome informatics to make the learning process and resulting map independent of the order of data input [41], [42]. In order to lower computational demands of BLSOM, a novel method Self-Compressing BLSOM (SC-BLSOM) was invented, which rapidly fastens the clustering process [43]. Although SOM can be an effective tool for cluster analysis, it also has its drawbacks. Firstly, the contour definition and therefore the final clustering can be hard task that significantly affects the results of taxonomic profiling. Secondly, the kernel transformation suffers from quadratic time complexity therefore it is time consuming. A solution to the second addressed problem is offered by VizBin [45] which also reduces the high-dimensional k-mers into two-dimensional space by use of the Barnes-Hut Stochastic Neighbor Embedding (BH-SNE) algorithm with time complexity only O(nlogn) compared to O(n2) of SOM [46], [47]. One of the major advantages of VizBin is that it provides rather distinctly bounded clusters in satisfactory time. On the other hand, the final binning is not automatic and the results are therefore purely dependent on human assessment which can be especially problematic with high-complexity metagenomic data.

Several parameters were combined in 2Tbinning [48], these include GC content, oligonucleotide frequency derived error gradient (OFDEG) [49] and tetramer frequency. 2Tbinning stands for 2-tier binning, as in the first tier sequences are separated into preliminary groups based on GC content and OFDEG parameter, and in the second tier, these groups are then separately divided into finer bins utilizing k-mer frequencies. Also MetaWatt [50] is a tool that bins sequences in two steps, where sequences are firstly separated into clusters regarding to an empirical relationship between the mean and standard deviation of tetramer frequencies. The optimal bins are then selected by an expert and used for creation of IMMs, which are then used for improvement of the binning results obtained in the first step, similarly to SCIMM. However, compared with SCIMM, which uses fully automatically defined bins for IMM modeling, MetaWatt requires human input.

2.2. Abundance based binning

One of the problems with the composition based methods is the binning of species with low abundance, as sequences belonging to these species form smaller indistinct clusters, which can then be easily misclassified as part of a larger bin belonging to highly abundant species. This issue can be solved by use of abundance based binning methods, which can be further subdivided into methods for working with one sample (AbundanceBin [51], MBBC [52]), and methods working with series of metagenomic samples (Canopy [53]). The key idea of the first group is that the distribution of sequenced reads follows the Lander-Waterman model, where coverage of each nucleotide can be computed by the application of the Poisson distribution [54]. The workflow of these methods is therefore somewhat similar to the composition based binning techniques, with the main difference in cluster formation being defined by k-mer abundance (content) instead of their similarity (composition). The second group of methods is based on the assumption that coverage profiles of contigs from the same genomes should be highly correlated across multiple samples. The necessary step lies in de novo assembly of raw reads into contigs, as shown in the schematic workflow in Fig. 2.

The second problem with composition based methods is that they usually provide reasonably accurate results only when longer sequences are used (e.g. 800 bp). AbundanceBin, the one-sample abundance based method, gives solution to this issue and can work accurately even with sequence reads that are only 75 bp long. The technique extracts l-tuples (l was experimentally estimated to 20) from all reads and then by use of the Expectation–Maximization (EM) algorithm, finds the parameters for the Poisson distributions, which reflect the relative abundance levels of the species. Since AbundanceBin uses a recursive binning approach for bin number estimation, there is no need for human input, which makes the method fully automatic. A user can still possibly change the initial conditions for the EM algorithm for the initial estimation of abundance levels and genome sizes, which are determined empirically for default mode. A similar pipeline to AbundanceBin is introduced in MBBC, where the initial binning is also performed by finding parameters for Poisson distributions by the EM algorithm; however, the outcome is then used for training Markov models, based on which the preliminary bins are refined. Although both of the methods work well even on very short sequences (e.g. 75 bp), the setting of initial conditions can be crucial for the outcome. Moreover, in MBBC, the user is required to enter a large number as an estimation of number of bins. While the number is then optimized, it is still unclear, what can be considered large for different samples, thus testing an optimal setting can be time consuming.

In order to overcome resolution limitations, in form of inability to separate closely related organisms, abundance can be computed and compared across many samples. Such resolution enhancement is introduced in Canopy, which clusters sequences based on gene abundance profiles across many samples. Since the method works only with gene regions, it requires use of MOCAT software package [55] for gene prediction. The canopy-based clustering is then performed simply by searching for genes within a predefined distance from a randomly picked gene, which has not been clustered yet. Bins are then further edited based on the gene content. The method therefore does not require predefined number of clusters or any other human input, making it fully automatic.

2.3. Hybrid binning

The hybrid binning methods combine the two aforementioned strategies into a compact technique. It has been previously proven that by combination of information about the sequence composition and coverage, which reflects the species abundance, one can extract more information about metagenomics data, which eventually leads to more accurate binning results [59].

The very first hybrid method was CompostBin [38]. Unlike the majority of sequence composition based methods requiring prior assembly, which can possibly lead to the formation of defective sequences, referred to as chimeric contigs; the workflow of CompostBin is designed in such way that the method can be applied directly onto raw reads. Initial extraction of hexamer frequencies is followed by principle component analysis (PCA) for dimensionality reduction, which is, however, weighted by an inverted value of sequence coverage. By applying the weights, the between species variance is not overwhelmed by within species variance of the more abundant species. Bins are then formed by the application of fully automatic recursive division algorithm on the data in the final lower-dimensional space; thus, no prior knowledge is required. Another method that uses PCA for dimensionality reduction is CONCOCT [56]. Here, the combined profile is constructed simply by concatenating the two vectors (k-mer frequency, and coverage) together while dimensionality reduction is carried out by simple unweighted PCA. All efficiency evaluators of CONCOCT were proven to grow with the number of samples; therefore, the minimal requirement for number of samples was empirically stated to be 50. CONCOCT uses a variational Bayesian approach for cluster number estimation in combination with the Gaussian mixture model (GMM) [57], which makes the binning independent of human input. Similarly to CONCOCT, COCACOLA [58] works with one feature vector, combining coverage across many samples with genomic signatures. This technique uses L1 distance instead of commonly used Euclidian distance to provide more reliable taxonomic binning results. Furthermore, the binning method combines advantages of soft, as well as hard clustering which eventually ensues in more robust results. COCACOLA, in addition to that, enables the incorporation of extra knowledge in the form of linkage of contigs provided by pair-end reads, and co-alignment to reference genomes into the binning method in order to enhance the binning performance.

MyCC [59] uses k-mer frequency vectors with optional addition of coverage information, which makes the method either hybrid, or composition based, in case that the coverage information is not available. The initial workflow is identical to the one used in VizBin from composition based binning section, but instead of human-augmented clustering, the affinity propagation algorithm is used for the creation of initial clusters, which are then fine-tuned by the identification of single-copy marker genes within the clusters. The universal single-copy marker genes are conserved in the majority of all sequenced bacteria and occur in exactly one copy [60] and can therefore be used as a measure of genome completeness or in case of MyCC as a useful tool for binning refinement. Although the binning method in MyCC is automatic, the affinity propagation algorithm has large memory demands and therefore, with constantly growing amount of metagenomics data, leaves space for further improvements.

Another technique working simultaneously with many samples is MetaBAT [61]. In this case, the method does not form a compact feature vector, but instead calculates probabilistic distances between pairs of sequences based on k-mer frequencies and abundance, and merges them into one composite distance. The probabilistic distances of tetranucleotide frequencies are computed utilizing an empirical model obtained by comparison of inter- and intraspecies distances of the known genomes, therefore, the validity of the model is verified only by the knowledge of already sequenced genomes. Even though the clustering method is fully automatic, the user is required to select one of the five predefined options regarding to the desired sensitivity and specificity. Same as MetaBAT, also MaxBin [60] works with probabilistic models. While the model based on the tetranucleotide frequencies was determined similarly using inter- and intraspecies Euclidian distances of 3181 known bacterial genomes, the difference can be found in the estimation of the model for coverage based probability distances. For a given pair of sequences, MetaBAT utilizes an area shared under normal distribution curves for quantification, whereas MaxBin adapts the Lander-Waterman model with the Poisson distribution. Clustering in MaxBin is then performed by EM algorithm. The technique uses universal single-copy marker genes for estimating the number of bins, parameter initiation and for polishing the binning output after running the EM algorithm. The original version of MaxBin was designed on single-sample data usage; however, the upgraded version, MaxBin 2.0 [62], has already allowed usage on multi-sample data, which leads to better binning results.

Software for binning of metagenomics data from several samples, such as, GroopM [63], uses primarily differential coverage of the samples accompanied by principal components of genomic signatures and by contig lengths. In this method, coverage of each sample represents one dimension in a high-dimensional space, which is then transformed by the use of unique transformation to 3D space in order to enable visualization. The binning is then performed in several steps, including two way clustering, followed by Hough partitioning on parameters formed by all, differential coverage, first principal components obtained from genomic signatures carrying at least 80% of variability, and by contig lengths. The preliminary bins are then refined by use of SOM and an optional user input.

Compared to the aforementioned methods, Differential Coverage Binning [64] uses dual information of one sample obtained by the application of two different DNA extraction methods (HP+, HP). The doubled information regarding the coverage of each sample allows a simple visualization in 2D space. The groups in the plot are labeled according to the occurrence of essential single-copy marker genes, allowing the user to manually select a desired cluster, which is then further processed by extracting genomic signatures and the performance of PCA providing useful information in further species segregation. In the next step, pair-end reads are used for creating a network, which after visualization in Cytoscape [65], can enhance the binning results. Although the method enables advanced visualization, binning is affected purely by a user. The last method introduced in this section: MetaCluster 5.0 [66] is a tool designed for single-sample binning. MetaCluster 5.0 is able to work with short reads (75 bp), and compared to its previous version MetaCluster 4.0 [67], also deals with issue of problematic separation of low-abundant species by two-round binning. The method first separates data into three groups based on coverage, namely (i) high abundance, (ii) low abundance, and (iii) extremely low abundance sequences. The extremely low abundance sequences are filtered out and binning is then done on the two remaining groups separately. In each group, the sequences are first clustered into preliminary bins referred to as virtual contigs based on content of identical long w-mers, where w is high. The whole virtual contigs are then processed as single sequences and based on their k-mer frequencies content clustered into the final bins by automatic k-means clustering algorithm using Spearman distance. The approach from MetaCluster 5.0 has also been adapted for utilization in an annotation pipeline and is named MetaCluster-TA [68].

2.4. Input data

Particular groups of different taxonomy independent strategies lay different requirements on input data; while the sequence composition based strategies can work directly with sequencing reads, the classification of very short fragments is problematic due to the high variation of DNA composition patterns within a single genome. Raw sequencing reads can be therefore processed by certain tools only if their length is sufficient. In general, the length of 2000 bp is considered to be a minimum, but the longer the sequences are, the better the binning result becomes. Direct classification of raw sequencing reads is therefore possible only for third generation sequencing platforms, e.g. PacBio [69] or Oxford Nanopore [70]. The abundance based methods utilizing distribution of sequenced reads following the Lander-Waterman model, on the contrary, can work with reads as short as 75 bp, making them capable to reliably bin reads from next generation sequencing platforms, e.g. Illumina, Roche 454 or Ion Torrent [71]. The remaining abundance based techniques, as well as most of hybrid methods usually require de novo assembly prior to binning, as they work with coverage profiles of analyzed contigs. Although standard de novo assembly tools, e.g. SOAPdenovo2 [72], Celera [73], Velvet [74], etc., can provide satisfactory assembly results, preferably novel specialized assemblers for metagenomic datasets, e.g. MetaVelvet [75], IDBA-UD [76], Ray Meta [77], etc., should be used. Contigs assembled from the next generation sequencing reads can be, of course, also used as an input for composition based methods to improve their performance.

The list of all tools including requirements for input data, programming language or interface and operating system is provided in Table 1. Basic knowledge of unix based OS and scripting languages is usually required as only 3 tools are equipped with graphical interface of which the single one can be considered as a standalone application. The rest of tools are rather packages using only command line interface. Several methods are only pipelines associating different algorithms by simple command line interface. Links for downloading the tools are also included in Table 1, except for 2Tbinning tool which is no longer available.

Table 1.

List of tool for taxonomy independent binning.

Method Software type Input data Programming languages* Interface Operating system Available from
SOM např. Package Raw reads or contigs Perl CLI Linux https://github.com/tetramerFreqs/Binning
LikelyBin Package Raw reads Perl, C CLI Linux http://ecotheory.biology.gatech.edu/downloads/likelybin
SCIMM Package Raw reads or contigs Python CLI Linux http://www.cbcb.umd.edu/software/scimm/
2Tbinning No longer available
MetaWatt Package Assembled contigs Java CLI, GUI for data exploration Linux, Mac OS https://sourceforge.net/projects/metawatt/
VizBin Standalone Contigs Java GUI Linux, Mac OS, Windows https://claczny.github.io/VizBin/
AbundanceBin Package Raw reads C ++ CLI Linux http://omics.informatics.indiana.edu/AbundanceBin/
Canopy Package Gene abundance profiles C ++ CLI Linux, Mac OS https://bitbucket.org/HeyHo/mgs-canopy-algorithm/wiki/Home
MBBC Package Raw reads Java CLI, GUI Linux, Windows http://eecs.ucf.edu/~xiaoman/MBBC/MBBC.html
CompostBin Package Raw reads C, Matlab CLI Linux https://sites.google.com/site/souravc/compostbin
MetaCluster Package Raw reads (only pair-ends) C ++ CLI Linux http://i.cs.hku.hk/~alse/MetaCluster/index.html
Dif. Cov. Bin. Pipeline Raw reads R CLI Linux https://github.com/MadsAlbertsen/multi-metagenome
CONCOCT Package Contigs + BAM Python CLI Linux, Mac OS https://github.com/BinPro/CONCOCT
MaxBin Package Contigs + (reads or abundance file) Perl CLI Linux, Mac OS https://sourceforge.net/projects/maxbin/
GroopM Package Contigs + BAM Python CLI Linux http://ecogenomics.github.io/GroopM/
MetaBAT Pipeline Contigs + BAM C ++ CLI Linux https://bitbucket.org/berkeleylab/metabat
COCACOLA Pipeline Contigs + raw reads Matlab CLI Linux https://github.com/younglululu/COCACOLA
MyCC Package Contigs + BAM*optional Python CLI Linux https://sourceforge.net/projects/sb2nhri/files/MyCC/

3. Visualization

Since taxonomy independent techniques perform clustering in unsupervised manner, the use of interactive inspection and visualization tools can be suitable for validity verification of the binning output. This way the user obtains a comprehensive outcome and, in case of GroopM, is also able to fine-tune the results of the automatic clustering methods [63]. The visualization methods use information regarding sequence composition or coverage to produce coordinates in two- or three-dimensional space to describe the given sequence. In some cases, the sequences can be visualized simply by the use of the parameters as coordinates without any further transformation. Such an example can be seen in LikelyBin, where each dimension is represented by loglikelihood of a given generated model, or in the first clustering tier of 2Tbinning, where one axis represents the GC content, while the second OFDEG of the sequence. Also the Differential Coverage Binning method uses simple coverage information of the two samples as sequence coordinates in the first visualization step.

In the majority of cases, the sequences are described by more than three parameters, disabling them from being projected into a humanly comprehensible space. Denouement is then brought by use of dimensionality reduction techniques, such as PCA, SOM, or t-distributed Stochastic Neighbor Embedding (t-SNE). Simple PCA is used on genomic signatures in the second visualization round in 2Tbinning, or in Differential Coverage Binning, in order to improve the species resolution in a selected group obtained by different visualization technique in the first round. Another method that uses simple PCA, this time on coverage-composition vectors, is CONCOCT. In CONCOCT the clusters are visualized in a 2D space by use of the first two principal components and highlighted by specific ellipses, which carry the information about the Gaussian mixtures used for the clustering. A modified version of PCA is used in CompostBin, where principle components are weighted based on sequence abundance within a sample. Such transformation allows the formation of more distinct clusters and therefore improved visualization. Another widely used dimensionality reduction technique in metagenomics is SOM. This technique has been used on both sequence composition based [32] and on abundance based data [78]. Although the technique can provide accurate results, contour definition can be a cumbersome task; moreover, the transformation lacks from quadratic time complexity, making SOM an unpleasantly time-consuming approach. Gisbrecht et al. [79] conducted a study on dimensionality reduction techniques in metagenomics. The research compared PCA with generative topographic mapping (GTM) [80], which is a probabilistic counterpart of SOM, and with t-SNE [81]. The study pointed out t-SNE as the most suitable dimensionality reduction method, but also mentioned its drawback in the form of quadratic time complexity. This issue has been solved by Laczny et al. [47], who used a modified version of t-SNE, called BH-SNE [46], reducing the time complexity to O(n log n). The suitability of the method for visualization reflects its broad use. Apart from the original visualization application VizBin, it has been incorporated into MyCC binning software and into IMP: a pipeline for reproducible integrated metagenomic and transcriptomic analyses [82].

Compared to previously mentioned techniques, GroopM uses an entirely unique transformation method for dimensionality reduction. The high-dimensional data in the form of differential coverage across multiple samples, where each sample forms one of N dimensions, is projected through the origin of the hyperplane X + Y + … + N = 1 into a human friendly 3D space. Similarly to the BH-SNE application on genomic signatures, this projection method also forms rather distinguished clusters. Another possibility to visualize metagenomic data is introduced as the third visualization step in Differential Coverage Binnig (after the visualization based on differential coverage and PCA of k-mer frequency of selected cluster) in the form of network based information obtained from paired-end reads. Such a network can further facilitate the binning process and interpretation of the metagenomic data.

4. Summary and outlook

Both of two main groups of taxonomy independent binning approaches, composition as well as abundance based strategies, have their own advantages and limitations. While composition based techniques usually provide clear visualization of analyzed microbiomes, they require relatively long sequences and are not reliable for complex microbial populations with low abundant communities. The second group of strategies, on the contrary, offers complementary properties. Abundance based techniques are capable to classify short reads of complex populations with many low abundant communities, without the ability to provide clear visual result. The third group of hybrid techniques combines both strategies to overcome particular drawbacks and combines some useful properties.

An important step in the classification of metagenomic datasets is a metagenome de novo assembly. This step precedes the actual binning and is not incorporated into the presented tools. However, the information acquired during classification can be used, not only to infer biological knowledge, but for additional reassembly of the datasets. Therefore, it can be expected that novel tools for taxonomy independent binning will be combined with specialized metagenomic assemblers into complex pipelines for metagenomic, metatranscriptomic and metabolomic analyses. One of the first efforts of such pipelines can be already found in the abovementioned IMP pipeline.

Acknowledgements

Supported by Brno University of Technology intra-university junior project FEKT/FIT-J-16-3335.

References

  • 1.Kaeberlein T., Lewis K., Epstein S.S. Isolating “uncultivable” microorganisms in pure culture in a simulated natural environment. Science. 2002;296(5570):1127–1129. doi: 10.1126/science.1070633. [DOI] [PubMed] [Google Scholar]
  • 2.Sleator R.D., Shortall C., Hill C. Metagenomics. Lett Appl Microbiol. 2008;47(5):361–366. doi: 10.1111/j.1472-765X.2008.02444.x. [DOI] [PubMed] [Google Scholar]
  • 3.Reddy T.B.K., Thomas A.D., Stamatis D., Bertsch J., Isbandi M., Jansson J. The Genomes OnLine Database (GOLD) v.5: a metadata management system based on a four level (meta)genome project classification. Nucleic Acids Res. 2014 doi: 10.1093/nar/gku950. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 4.Rondon M.R., August P.R., Bettermann A.D., Brady S.F., Grossman T.H., Liles Cloning the soil metagenome: a strategy for accessing the genetic and functional diversity of uncultured microorganisms. Appl Environ Microbiol. 2000;66(6):2541–2547. doi: 10.1128/aem.66.6.2541-2547.2000. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 5.Kennedy J., Marchesi J.R., Dobson A.D.W. Marine metagenomics: strategies for the discovery of novel enzymes with biotechnological applications from marine environments. Microb Cell Fact. 2008;7(1):1–8. doi: 10.1186/1475-2859-7-27. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 6.Cho I., Blaser M.J. The human microbiome: at the interface of health and disease. Nat Rev Genet. April 2012;13(4):260–270. doi: 10.1038/nrg3182. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 7.Tyson G.W., Chapman J., Hugenholtz P., Allen E.E., Ram R.J., Richardson P.M. Community structure and metabolism through reconstruction of microbial genomes from the environment. Nature. 2004;428(6978):37–43. doi: 10.1038/nature02340. [DOI] [PubMed] [Google Scholar]
  • 8.Simon C., Rolf D. Metagenomic analyses: past and future trends. Appl Environ Microbiol. 2011;77(4):1153–1161. doi: 10.1128/AEM.02345-10. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 9.Kurokawa K., Itoh T., Kuwahara T., Oshima K., Toh H., Toyoda A. Comparative metagenomics revealed commonly enriched gene sets in human gut microbiomes. DNA Res. 2007;14(4):169–181. doi: 10.1093/dnares/dsm018. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 10.Frank J.A., Pan Y., Tooming-Klunderud A., Eijsink V.G.H., Mchardy A.C., Nederbragt A.J. Improved metagenome assemblies and taxonomic binning using long-read circular consensus sequence data. Sci Rep. 2016;6:25373. doi: 10.1038/srep25373. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 11.Aguiar-Pulido V., Huang W., Suarez-Ulloa V., Cickovski T., Mathee K., Narasimhan G. Metagenomics, metatranscriptomics, and metabolomics approaches for microbiome analysis. Evol Bioinforma. 2016;12(S1):5–16. doi: 10.4137/EBO.S36436. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 12.Tringe S.G., Von Mering C., Kobayashi A., Salamov A.A., Chen K., Chang H.W. Comparative metagenomics of microbial communities. Science. 2005;308(5721):554–557. doi: 10.1126/science.1107851. [DOI] [PubMed] [Google Scholar]
  • 13.Bikel S., Valdez-Lara A., Cornejo-Granados F., Rico K., Canizales-Quinteros S., Soberón X. Combining metagenomics, metatranscriptomics and viromics to explore novel microbial interactions: towards a systems-level understanding of human microbiome. Comput Struct Biotechnol J. 2015;13:390–401. doi: 10.1016/j.csbj.2015.06.001. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 14.Scholz M.B., Lo C.-C., Chain P.S.G. Next generation sequencing and bioinformatic bottlenecks: the current state of metagenomic data analysis. Curr Opin Biotechnol. 2012;23(1):9–15. doi: 10.1016/j.copbio.2011.11.013. [DOI] [PubMed] [Google Scholar]
  • 15.Langille M.G.I., Zaneveld J., Caporaso J.G., Mcdonald D., Knights D., Reyes J.A. Predictive functional profiling of microbial communities using 16S rRNA marker gene sequences. Nat Biotechnol. 2013;31(9):814–821. doi: 10.1038/nbt.2676. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 16.Unterseher M., Jumpponen A., Opik M., Tedersoo L., Moora M., Dormann C.F. Species abundance distributions and richness estimations in fungal metagenomics--lessons learned from community ecology. Mol Ecol. 2011;20(2):275–285. doi: 10.1111/j.1365-294X.2010.04948.x. [DOI] [PubMed] [Google Scholar]
  • 17.Ribeca P., Valiente G. Computational challenges of sequence classification in microbiomic data. Brief Bioinform. 2011;12(6):614–626. doi: 10.1093/bib/bbr019. [DOI] [PubMed] [Google Scholar]
  • 18.Klindworth A., Pruesse E., Schweer T., Peplies J., Quast C., Horn M. Evaluation of general 16S ribosomal RNA gene PCR primers for classical and next-generation sequencing-based diversity studies. Nucleic Acids Res. 2012 doi: 10.1093/nar/gks808. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 19.Sedlar K., Videnska P., Skutkova H., Rychlik I., Provaznik I. Bipartite graphs for visualization analysis of microbiome data. Evol Bioinforma. 2016;12(S1):17–23. doi: 10.4137/EBO.S38546. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 20.Sharpton T.J. An introduction to the analysis of shotgun metagenomic data. Front Plant Sci. 2014;5:209. doi: 10.3389/fpls.2014.00209. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 21.Reuter J.A., Spacek D.V., Snyder M.P. High-throughput sequencing technologies. Mol Cell. 2015;58(4):586–597. doi: 10.1016/j.molcel.2015.05.004. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 22.Pevzner P.A., Tang H., Waterman M.S. An Eulerian path approach to DNA fragment assembly. Proc Natl Acad Sci. 2001;98(17):9748–9753. doi: 10.1073/pnas.171285098. [Proceedings of the National Academy of Sciences] [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 23.Altschul S.F., Gish W., Miller W., Myers E.W., Lipman D.J. Basic local alignment search tool. J Mol Biol. 1990;215(3):403–410. doi: 10.1016/S0022-2836(05)80360-2. [DOI] [PubMed] [Google Scholar]
  • 24.Kent W.J. BLAT—the BLAST-Like Alignment Tool. Genome Res. 2002;12(4):656–664. doi: 10.1101/gr.229202. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 25.Langmead B., Trapnell C., Pop M., Salzberg S.L. Ultrafast and memory-efficient alignment of short DNA sequences to the human genome. Genome Biol. 2009;10(3):1–10. doi: 10.1186/gb-2009-10-3-r25. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 26.Li H., Durbin R. Fast and accurate long-read alignment with Burrows–Wheeler transform. Bioinformatics. 2010;26(5):589–595. doi: 10.1093/bioinformatics/btp698. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 27.Finn R.D., Coggill P., Eberhardt R.Y., Eddy S.R., Mistry J., Mitchell A.L. The Pfam protein families database: towards a more sustainable future. Nucleic Acids Res. 2016;44(D1):D279–D285. doi: 10.1093/nar/gkv1344. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 28.Vinga S., Almeida J. Alignment-free sequence comparison—a review. Bioinformatics. 2003;19(4):513–523. doi: 10.1093/bioinformatics/btg005. [DOI] [PubMed] [Google Scholar]
  • 29.Teeling H., Glöckner F.O. Current opportunities and challenges in microbial metagenome analysis—a bioinformatic perspective. Brief Bioinform. 2012 doi: 10.1093/bib/bbs039. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 30.Sayers E.W., Barrett T., Benson D.A., Bryant S.H., Canese K., Chetvernin V. Database resources of the National Center for Biotechnology Information. Nucleic Acids Res. 2009;37(Suppl. 1) doi: 10.1093/nar/gkn741. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 31.Mande S.S., Mohammed M.H., Ghosh T.S. Classification of metagenomic sequences: methods and challenges. Brief Bioinform. 2012;13(6):669–681. doi: 10.1093/bib/bbs054. [DOI] [PubMed] [Google Scholar]
  • 32.Dick G.J., Andersson A.F., Baker B.J., Simmons S.L., Thomas B.C., Yelton Community-wide analysis of microbial genome sequence signatures. Genome Biol. 2009;10(8):R85. doi: 10.1186/gb-2009-10-8-r85. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 33.Gori F., Mavroedis D., Jetten M.S.M., Marchiori E. 2011 IEEE International Conference on Systems Biology (ISB) 2011. Genomic signatures for metagenomic data analysis: exploiting the reverse complementarity of tetranucleotides; pp. 149–154. [Google Scholar]
  • 34.Land M., Hauser L., Jun S.-R., Nookaew I., Leuze M.R. Insights from 20 years of bacterial genome sequencing. Funct Integr Genomics. 2015;15(2):141–161. doi: 10.1007/s10142-015-0433-4. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 35.Teeling H., Waldmann J., Lombardot T., Bauer M., Glöckner F.O. TETRA: a web-service and a stand-alone program for the analysis and comparison of tetranucleotide usage patterns in DNA sequences. BMC Bioinform. 2004;5(1):163. doi: 10.1186/1471-2105-5-163. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 36.Kislyuk A., Bhatnagar S., Dushoff J., Weitz J.S. Unsupervised statistical clustering of environmental shotgun sequences. BMC Bioinform. 2009;10(1):316. doi: 10.1186/1471-2105-10-316. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 37.Kelley D.R., Salzberg S.L. Clustering metagenomic sequences with interpolated Markov models. BMC Bioinform. 2010;11(1):544. doi: 10.1186/1471-2105-11-544. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 38.Chatterji, Sourav, Yamazaki, Ichitaro, Bai, Zhaojun, Eisen, Jonathan A. CompostBin: a DNA composition-based algorithm for binning environmental shotgun reads. Lect Notes Comput Sci. 2008:17–28. [Google Scholar]
  • 39.Brown C.T., Sharon I., Thomas B.C., Castelle C.J., Morowitz M.J., Banfield J.F. Genome resolved analysis of a premature infant gut microbial community reveals a Varibaculum cambriense genome and a shift towards fermentation-based metabolism during the third week of life. Microbiome. 2013;1(1):30. doi: 10.1186/2049-2618-1-30. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 40.Wrighton K.C., Thomas B.C., Sharon I., Miller C.S., Castelle C.J., Verberkmoes N.C. Fermentation, hydrogen, and sulfur metabolism in multiple uncultivated bacterial phyla. Science. 2012;337(6102):1661–1665. doi: 10.1126/science.1224041. [DOI] [PubMed] [Google Scholar]
  • 41.Abe T., Hamano Y., Ikemura T. Visualization of genome signatures of eukaryote genomes by batch-learning self-organizing map with a special emphasis on Drosophila genomes. Biomed Res Int. 2014;2014:1–8. doi: 10.1155/2014/985706. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 42.Abe T., Sugawara H., Kinouchi M., Kanaya S., Ikemura T. Novel phylogenetic studies of genomic sequence fragments derived from uncultured microbe mixtures in environmental and clinical samples. DNA Res. 2006;12(5):281–290. doi: 10.1093/dnares/dsi015. [DOI] [PubMed] [Google Scholar]
  • 43.Kikuchi A., Ikemura T., Abe T. Development of self-compressing BLSOM for comprehensive analysis of big sequence data. Biomed Res Int. 2015;2015:1–8. doi: 10.1155/2015/506052. [Hindawi Publishing Corporation] [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 44.Kohonen T. The self-organizing map. Proc IEEE. 1990;78(9):1464–1480. [Google Scholar]
  • 45.Laczny C.C., Sternal T., Plugaru V., Gawron P., Atashpendar A., Margossian H. VizBin - an application for reference-independent visualization and human-augmented binning of metagenomic data. Microbiome. 2015;3(1):1. doi: 10.1186/s40168-014-0066-1. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 46.Van Der Maaten L. Accelerating t-SNE using tree-based algorithms. J Mach Learn Res. 2014;15:3221–3245. [Google Scholar]
  • 47.Laczny C.C., Pinel N., Vlassis N., Wilmes P. Alignment-free visualization of metagenomic data by nonlinear dimension reduction. Sci Rep. 2014;4 doi: 10.1038/srep04516. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 48.Saeed I., Tang S.-L., Halgamuge S.K. Unsupervised discovery of microbial population structure within metagenomes using nucleotide base composition. Nucleic Acids Res. 2011;40(5):e34. doi: 10.1093/nar/gkr1204. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 49.Saeed I., Halgamuge S.K. The oligonucleotide frequency derived error gradient and its application to the binning of metagenome fragments. BMC Genomics. 2009;10(Suppl. 3):S10. doi: 10.1186/1471-2164-10-S3-S10. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 50.Strous M., Kraft B., Bisdorf R., Tegetmeyer H.E. The binning of metagenomic contigs for microbial physiology of mixed cultures. Front Microbiol. 2012;3 doi: 10.3389/fmicb.2012.00410. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 51.Wu Y.-W., Ye Y. A novel abundance-based algorithm for binning metagenomic sequences using l -tuples. J Comput Biol. 2011;18(3):523–534. doi: 10.1089/cmb.2010.0245. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 52.Wang Y., Hu H., Li X. MBBC: an efficient approach for metagenomic binning based on clustering. BMC Bioinform. 2015;16(1) doi: 10.1186/s12859-015-0473-8. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 53.Nielsen H.B., Almeida M., Juncker A.S., Rasmussen S., Li J., Sunagawa Identification and assembly of genomes and genetic elements in complex metagenomic samples without using reference genomes. Nat Biotechnol. 2014;32(8):822–828. doi: 10.1038/nbt.2939. [DOI] [PubMed] [Google Scholar]
  • 54.Lander E.S., Waterman M.S. Genomic mapping by fingerprinting random clones: a mathematical analysis. Genomics. 1988;2(3):231–239. doi: 10.1016/0888-7543(88)90007-9. [DOI] [PubMed] [Google Scholar]
  • 55.Kultima J.R., Sunagawa S., Li J., Chen W., Chen H., Mende D.R. MOCAT: a metagenomics assembly and gene prediction toolkit. PLoS One. 2012;7(10):e47656. doi: 10.1371/journal.pone.0047656. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 56.Alneberg J., Bjarnason B.S., De Bruijn I., Schirmer M., Quick J., Ijaz U.Z. Binning metagenomic contigs by coverage and composition. Nat Methods. 2014;11(11):1144–1146. doi: 10.1038/nmeth.3103. [DOI] [PubMed] [Google Scholar]
  • 57.Corduneanu A., Bishop C.M. Variational Bayesian model selection for mixture distributions. Artif Intell Stat. 2001:27–34. [Google Scholar]
  • 58.Lu Y.Y., Chen T., Fuhrman J.A., Sun F. COCACOLA: binning metagenomic contigs using sequence COmposition, read CoverAge, CO-alignment and paired-end read LinkAge. Bioinformatics. 2016:btw290. doi: 10.1093/bioinformatics/btw290. [DOI] [PubMed] [Google Scholar]
  • 59.Lin H.-H., Liao Y.-C. Accurate binning of metagenomic contigs via automated clustering sequences using information of genomic signatures and marker genes. Sci Rep. 2016;6:24175. doi: 10.1038/srep24175. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 60.Wu Y.-W., Tang Y.-H., Tringe S.G., Simmons B.A., Singer S.W. MaxBin: an automated binning method to recover individual genomes from metagenomes using an expectation–maximization algorithm. Microbiome. 2014;2(1):26. doi: 10.1186/2049-2618-2-26. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 61.Kang D.D., Froula J., Egan R., Wang Z. MetaBAT, an efficient tool for accurately reconstructing single genomes from complex microbial communities. PeerJ. 2015;3:e1165. doi: 10.7717/peerj.1165. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 62.Wu Y.-W., Simmons B.A., Singer S.W. MaxBin 2.0: an automated binning algorithm to recover genomes from multiple metagenomic datasets. Bioinformatics. 2015;32(4):605–607. doi: 10.1093/bioinformatics/btv638. [DOI] [PubMed] [Google Scholar]
  • 63.Imelfort M., Parks D., Woodcroft B.J., Dennis P., Hugenholtz P., Tyson G.W. GroopM: an automated tool for the recovery of population genomes from related metagenomes. PeerJ. 2014;2:e603. doi: 10.7717/peerj.603. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 64.Albertsen M., Hugenholtz P., Skarshewski A., Nielsen K.L., Tyson G.W., Nielsen P.H. Genome sequences of rare, uncultured bacteria obtained by differential coverage binning of multiple metagenomes. Nat Biotechnol. 2013;31(6):533–538. doi: 10.1038/nbt.2579. [DOI] [PubMed] [Google Scholar]
  • 65.König M. cy3sabiork: a Cytoscape app for visualizing kinetic data from SABIO-RK. F1000Research. 2016;5:1736. [Google Scholar]
  • 66.Wang Y., Leung H.C.M., Yiu S.M., Chin F.Y.L. MetaCluster 5.0: a two-round binning approach for metagenomic data for low-abundance species in a noisy sample. Bioinformatics. 2012;28(18):i356–i362. doi: 10.1093/bioinformatics/bts397. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 67.Wang Y., Leung H.C.M., Yiu S.M., Chin F.Y.L. MetaCluster 4.0: a novel binning algorithm for NGS reads and huge number of species. J Comput Biol. 2012;19(2):241–249. doi: 10.1089/cmb.2011.0276. [DOI] [PubMed] [Google Scholar]
  • 68.Wang Y., Leung H., Yiu S., Chin F. MetaCluster-TA: taxonomic annotation for metagenomic data based on assembly-assisted binning. BMC Genomics. 2014;15(Suppl. 1):S12. doi: 10.1186/1471-2164-15-S1-S12. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 69.Rhoads A., Au K.F. PacBio sequencing and its applications. Genomics Proteomics Bioinformatics. 2015;13(5):278–289. doi: 10.1016/j.gpb.2015.08.002. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 70.Mikheyev A.S., Tin M.M.Y. A first look at the Oxford Nanopore MinION sequencer. Mol Ecol Resour. 2014;14(6):1097–1102. doi: 10.1111/1755-0998.12324. [DOI] [PubMed] [Google Scholar]
  • 71.Shokralla S., Spall J.L., Gibson J.F., Hajibabaei M. Next-generation sequencing technologies for environmental DNA research. Mol Ecol. 2012;21(8):1794–1805. doi: 10.1111/j.1365-294X.2012.05538.x. [DOI] [PubMed] [Google Scholar]
  • 72.Luo R., Liu B., Xie Y., Li Z., Huang W., Yuan J. SOAPdenovo2: an empirically improved memory-efficient short-read de novo assembler. GigaScience. 2012;1(1):1–6. doi: 10.1186/2047-217X-1-18. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 73.Pevzner P.A., Tang H., Waterman M.S. An Eulerian path approach to DNA fragment assembly. Proc Natl Acad Sci. 2001;98(17):9748–9753. doi: 10.1073/pnas.171285098. [online] [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 74.Zerbino D.R., Birney E. Velvet: algorithms for de novo short read assembly using de Bruijn graphs. Genome Res. 2008;18(5):821–829. doi: 10.1101/gr.074492.107. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 75.Namiki T., Hachiya T., Tanaka H., Sakakibara Y. MetaVelvet: an extension of Velvet assembler to de novo metagenome assembly from short sequence reads. Nucleic Acids Res. 2012;40(20):e155. doi: 10.1093/nar/gks678. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 76.Peng Y., Leung H.C.M., Yiu S.M., Chin F.Y.L. IDBA-UD: a de novo assembler for single-cell and metagenomic sequencing data with highly uneven depth. Bioinformatics. 2012;28(11):1420–1428. doi: 10.1093/bioinformatics/bts174. [DOI] [PubMed] [Google Scholar]
  • 77.Boisvert S., Raymond F., Godzaridis É., Laviolette F., Corbeil J. Ray Meta: scalable de novo metagenome assembly and profiling. Genome Biol. 2012;13(12):1–13. doi: 10.1186/gb-2012-13-12-r122. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 78.Sharon I., Morowitz M.J., Thomas B.C., Costello E.K., Relman D.A., Banfield J.F. Time series community genomics analysis reveals rapid shifts in bacterial species, strains, and phage during infant gut colonization. Genome Res. 2012;23(1):111–120. doi: 10.1101/gr.142315.112. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 79.Gisbrecht A., Hammer B., Mokbel B., Sczyrba A. 2013 17th International Conference on Information Visualisation. 2013. Nonlinear dimensionality reduction for cluster identification in metagenomic samples. [Google Scholar]
  • 80.Bishop C.M., Svensén M., Williams C.K.I. GTM: the generative topographic mapping. Neural Comput. 1998;10(1):215–234. [Google Scholar]
  • 81.Van Der Maaten L., Hinton G.E. Visualizing high-dimensional data using t-SNE. J Mach Learn Res. 2008;9:2579–2605. [Google Scholar]
  • 82.Narayanasamy S., Jarosz Y., Muller E., Laczny C., Herold M., Kaysen A. IMP: a pipeline for reproducible metagenomic and metatranscriptomic analyses. bioRxiv. 2016:039263. doi: 10.1186/s13059-016-1116-8. [DOI] [PMC free article] [PubMed] [Google Scholar]

Articles from Computational and Structural Biotechnology Journal are provided here courtesy of Research Network of Computational and Structural Biotechnology

RESOURCES