Skip to main content

Using 16S rRNA gene as marker to detect unknown bacteria in microbial communities

Abstract

Background

Quantification and identification of microbial genomes based on next-generation sequencing data is a challenging problem in metagenomics. Although current methods have mostly focused on analyzing bacteria whose genomes have been sequenced, such analyses are, however, complicated by the presence of unknown bacteria or bacteria whose genomes have not been sequence.

Results

We propose a method for detecting unknown bacteria in environmental samples. Our approach is unique in its utilization of short reads only from 16S rRNA genes, not from entire genomes. We show that short reads from 16S rRNA genes retain sufficient information for detecting unknown bacteria in oral microbial communities.

Conclusion

In our experimentation with bacterial genomes from the Human Oral Microbiome Database, we found that this method made accurate and robust predictions at different read coverages and percentages of unknown bacteria. Advantages of this approach include not only a reduction in experimental and computational costs but also a potentially high accuracy across environmental samples due to the strong conservation of the 16S rRNA gene.

Background

In these profiling microbial communities, the main objective is to identify which bacteria and how much they are present in the environments. Most microbial profiling methods focus on the identification and quantification of bacteria with already sequenced genomes. Further, most methods utilize information obtained from entire genomes. Homology-based methods such as [1–4] classify sequences by detecting homology in reads belonging to either an entire genome or only a small set of marker genes. Composition-based methods generally use conserved compositional features of genomes for classification and as such they utilize less computational resources. Taxy [5] uses k-mer distribution in reference genomes and metagenomes and a mixture model to identify the organisms. RAIphy [6] uses k-mers to build relative abundance index, classification metric and the iterative algorithm to refine the model and estimate the abundance. Composition-based method have been proven to be efficient for the analysis of metagenomes, but its accuracy depends on the selection of informative reference genomes, which are used to find sequence characteristics. CLARK [7] uses target-specific or discriminative k-mers, which are genomic regions that uniquely characterize each genome. Then, reads are assigned to the genome based on the highest number of matches of the reads’ k-mers to a target-specific k-mer set.

Although the main objective of metagenomics analysis focuses on profiling known bacteria, it is complicated by the presence of unknown bacteria (or those without sequenced genomes). To the best of our knowledge, only MicrobeGPS [8] provides a basic analysis of unknown bacteria in how they are similar to known bacteria. It does not address the scenario where unknown bacterial genomes are vastly different from already-sequenced reference genomes.

To address this challenge, this work focuses on identifying and quantifying unknown bacteria in microbial communities. In this context, unknown bacteria are those whose genomes have not been sequenced. Given short reads from a microbial community that contain genomic materials from known and unknown bacteria, the method works by (i) first separating reads from known bacteria and unknown bacteria, and then (ii) clustering reads from unknown bacteria into multiple clusters; each cluster represents a hypothetical unknown bacterium. Importantly, the method utilizes only reads from 16S rRNA genes as a means to accomplish these tasks. Due to its high conservation, historically, the 16S rRNA gene has been used as a marker for taxonomic and phylogenetic analyses ([9, 10]). In the context of metagenomics, whose analyses depend on only short reads and not entire genes, the 16S rRNA gene was recently used as a means to construct functional profiles of microbial communities [11].

Using the 16S rRNA gene instead of whole genome information is not only computational efficient but also economical; Illumina indicated that targeted sequencing of a focused region of interest reduces sequencing costs and enables deep sequencing, compared to whole-genome sequencing. On the other hand, as observed by [8], by focusing exclusively on one gene, one might lose essential information for advanced analyses. We, however, will provide an analysis that demonstrates that at least in the context of oral microbial communities, the 16S rRNA gene retains sufficient information to allow us detect unknown bacteria.

Methods

Overview

Our method for identifying unknown bacteria from short reads that come from 16S rRNA genes of all bacteria (including known and unknown bacteria) in an environmental sample works as follows:

  1. 1.

    Reads are first roughly assigned to known bacteria. This is done by aligning those reads to the collection of already-sequenced 16S rRNA genes of known bacteria. The alignment process can be done using a good aligners such as Bowtie2 [12], BWA-MEM [13], Soap2 [14], RandAL [15]. We used Bowtie2 due to the efficiency and flexibility of the software package. The aligner works by creating an index \(\mathcal {R}\) of reference 16S rRNA genes, which come from known (already-sequenced) bacterial genomes.

  2. 2.

    Reads that are not mapped to \(\mathcal {R}\) are presumed to belong to 16S rRNA genes of unknown bacteria. We used SAMtools [10, 16] to collect unmapped reads from the results of Bowtie2. At this point, it is possible and actually expected that (i) some reads that belong to unknown bacteria have been mistakenly mapped to \(\mathcal {R}\), and (ii) some reads that belong to the 16S rRNA gene of some known bacteria are mistakenly not mapped to \(\mathcal {R}\). Thus, the set of unmapped reads, \(\mathcal {U}\), contain both false positives and false negatives.

  3. 3.

    The unmapped reads, \(\mathcal {U}\), are then clustered into distinct clusters. Each cluster represents a hypothetical unknown bacterium. An additional post-processing step can be applied to (i) remove clusters with too few reads as they do not possess sufficient information and (ii) split large clusters that might contain reads belong to more than one bacteria. At this point, it is possible that (i) multiple clusters can represent the same unknown bacterium and (ii) an unknown bacterium is not represented at all by any cluster. Both cases are not desirable and they both affect the accuracy of predicting the number of unknown bacteria.

Uniqueness of the 16S rRNA gene in the human oral microbiome

Using the 16S rRNA gene as marker instead of the whole genome for identification and profiling bacterial communities potentially can lose a lot of information. On the other hand, this gene is highly conserved, which means that using it as the marker is more advantageous than using the whole genome since the reference gene in our database is less likely to be different than the gene in bacteria collected from environmental samples. Our analysis with a dataset that consists of 889 bacteria in the Human Oral Microbiome database suggests that the use of the 16S rRNA gene as marker is justified because there is a sufficient amount of information in this gene among different bacteria to help distinguish these bacteria. Consequently, the use of the 16S rRNA gene as marker to distinguish bacteria enjoys both the advantageous characteristics of the gene and having sufficient information required for the task.

To analyze the effectiveness of using the 16S rRNA gene as marker, we quantify the uniqueness of the gene among the set of 16S rRNA genes in bacteria of interest. To be precise, let G={g 1,g 2,⋯,g n } be the set of 16S rRNA genes of bacteria of interest. Define U(k,g i ,g j ) to be the number of k-mers in g i that are not in g j or \(g_{j}^{rc}\) divided by |g i |−k+1, where \(g_{j}^{rc}\) is the reverse complement of g j . Note that 0≤U(k,g i ,g j )≤1. In particular, U(k,g i ,g j ) being 1 means that all k-mers in g i do not occur in g j or \(g_{j}^{rc}\). Thus, when U(k,g i ,g j )=1, it is likely that reads much longer than k coming from g i will not be mistakenly mapped to g j . Further, for each g i , define

$$U(k, g_{i}) = \min_{1 \le j \le n, j \neq i} U(k, g_{i}, g_{j}) $$

Thus, the uniqueness score, U(k,g i ), is a conservative measure of uniqueness of g i in the whole set G. The closer U(k,g i ) is to 1, the more unique it is, and the more likely that reads much longer than k from g i will not be mistakenly mapped to any other gene g j in G.

Figure 1 shows, for different values of k, the distributions of U(k,g i ) of 889 16S rRNA genes obtained from the Human Oral Microbiome database. We can see that the distribution of U(6,k i ) peaks at around 0.58; i.e. around 88 genes have uniqueness scores at approximately 0.58. When k=8, most genes have uniqueness scores at around 0.97. When k=16, most genes have uniqueness scores at 1. When k≥18, we observed that all genes have uniqueness score of 1. This means for each gene in G, we can distinguish it with other genes using 18-mers. It also means that given reads produced by current technologies (e.g. ≥10), it is likely that reads that come from some gene g i will not be mistakenly mapped to any gene other than g i .

Fig. 1
figure 1

Distributions of U(k,g i ) of 16S rRNA genes suggest that k-mers longer than 16 can effectively be used to distinguish bacteria in the human oral microbiome

Clustering unmapped reads

The clustering procedure described in Step 3 of Section Overview is a critical component of this method. Technically, each cluster is a collection of reads that cover a contiguous genomic region. In other words, if one was to align these reads to the correct genomic region of a 16S rRNA that contains these reads, they would form a contiguous sequence. See Fig. 2.

Fig. 2
figure 2

Reads mapped to a contiguous region of a 16S rRNA gene

We employ the data structure that is similar to a Union-Find data structure [17] to partition unmapped reads in \(\mathcal {U}\) into a disjoint set of subsets. Each subset or cluster would represent a contiguous genomic region. This data structure C has following methods:

  • MakeSet(x), which creates a singleton set containing the element x.

  • Union(x,y), which unions the two disjoint sets that contain, respectively, x and y.

  • Find(x), which finds the set that contains x.

  • Clusters(), which returns all disjoint subsets that C maintains.

These methods can be encapsulated in data structure that is similar to the Union-Find data structure. Given the set of unmapped reads, \(\mathcal {U}\), the clustering procedure (as described in Step 3, Section Overview) can be described in Algorithm 1, which is described in an inefficient manner to help understandability; our actual implementation is more efficient. Essentially, the procedure looks at all pairs of unmapped reads and – if they overlap – merges the contigs to which they belong. Since reads can be in either the primary or the complementary strand, the determination of overlapping of two reads must account for this fact. First, given two sequences, define O(a,b)=HAM(pre(a,k),suf(b,k)), where pre(a,k) is the k-prefix of a; suf(b,k) is the k-suffix of b; and HAM is the Hamming distance function. Then, the overlapping of two reads x and y is determined as follows: Overlap(x,y) is True and only if

$${\max(O(x,y), O(x^{rc},y), O(x,y^{rc}), O(x^{rc},y^{rc})) \over \min(|x|, |y|)} \ge \tau $$

where |x| is the length of x; x rc is the reverse complement of x; and Ï„ is an empirically determined parameter.

Post clustering processing

Clusters produced by Algorithm 1 are predicted raw representations of different bacteria. Additional processing can be done to improve prediction accuracy. In particular, two heuristics can be employed. First, clusters containing too few reads should be removed as they do not possess enough information to give sufficient confidence in prediction. Second, clusters with too many reads might contain reads that belong to more than one bacteria. We consider heuristics that decompose graphs into large disjoint clusters representing different bacteria. One of such heuristics is based on a well-studied problem in network analysis: decomposition of graphs into dense subgraphs [18]. To adopt this strategy, we represent the set of unmapped reads in cluster i as a graph, G i , in which vertices represent reads and edges represent overlapping of read pairs. Specifically, there is an edge (u,v), if and only if Overlap (u,v) is true. As defined in Section Clustering Unmapped Reads, the function Overlap examines the overlapping of reads as well their reverse complements. With this representation, reads within each cluster that belong to different bacteria tend to form dense subgraphs of G i . These subgraphs are connected with each other by edges that represent the overlapping of similar reads belonging to different bacteria.

Method evaluation

As clusters returned by Algorithm 1 represent predicted species, the quality of prediction can be quantified in terms of how closely the clusters resemble the set of bacteria that reads belong to. Let T={T 1,⋯,T n } be the set of bacteria that unmapped reads belong to and C={C 1,⋯,C m } be the set of clusters that our method assigns the reads to. Although there are many different ways the accuracy of clusterings can be evaluated, we chose four different metrics that evaluate clustering quality in different meaningful and complementary ways.

Mutual information is an information-theoretic measure of how similar two joint distributions are. In the context of clustering, the mutual information between two clusterings T and C is defined as

$$MI(T, C) = \sum\limits_{i=1}^{n} \sum\limits_{j=1}^{m} P(i,j) \log {P(i,j) \over P(i) P(j)} $$

where P(i,j) is the probability that a read belongs to both T i and C j ; P(i) is the probability that a read belongs to T i ; P(j) is the probability that a read belongs to C j . The Adjusted Mutual Information (AMI) [19] of two clusterings is an adjustment of mutual information to account for chance and is defined as follows:

$$AMI(T, C)={MI(T, C) - E(MI(T, C)) \over \max(H(T), H(C)) - E(MI(T, C))} $$

where E(MI(T,C)) is the expected mutual information of two random clusterings and H(T) is the entropy of the clustering T. An AMI value of 0 occurs when the two clusterings are random, whereas a value of 1 occurs when C and T are identical.

Rand Index is a common measure in classification problems, where the measure takes into account directly the number of correctly and incorrectly classified items.

$$ RI(T,C) = {2(a+b) \over n(n-1)} $$

where a is the number of pairs of reads that are in the same cluster in T and C; and b is the number of pairs of reads that are in different clusters in T and C. The Adjusted Rand Index (ARI) was introduced to take into account when the Rand Index of two random clusterings is not a constant value [20]. An ARI value of 0 occurs when two C and T are independent, whereas a value of 1 means C and T are identical.

In addition to AMI and ARI, we also considered two complementary metrics, introduced by [21]: homogeneity and completeness. A clustering is homogenous if each cluster C j contains only reads that come from some bacterium T i . A clustering is complete if all reads that belong to any bacterium T i are placed into some cluster C j . These two metrics are opposing in that it is often hard to achieve high scores on both homogeneity and completeness. A few examples might help understand this intuition:

  • T=C if and only if both homogeneity are completeness scores are 1. T being identical to C only occurs when reads in each T i are placed in exactly one C j , and all reads in each C j come only from one T i .

  • Suppose T={{r 1,r 2},{r 3,r 4}} and C = {{r 1,r 2,r 3,r 4}}. Then, the completeness score is 1, because all reads that belong to T 1 (and respectively to T 2) are placed in the same cluster in C. On the other hand, the homogeneity score is 0, because reads in the only cluster in C come from different bacteria in T.

  • Suppose T={{r 1,r 2},{r 3,r 4}} and C={{r 1,r 3},{r 2,r 4}}. Then, both completeness and homogeneity scores are 0.

Results and discussion

In this section, we report experimental results that show various aspects of accuracy and robustness of this method. Accuracy is measured by four different metrics Adjusted Mutual Information (AMI), Adjusted Rand Index (ARI), Homogeneity and Completeness.

Mock microbial communities

Experiments were conducted on 16S rRNA genes obtained from 889 sequences cataloged by the Human Oral Microbiome Database. The lengths of genes vary between 1,323 to 1,656 bases. We simulated mock microbial communities at various settings in order to be able to compare ground truths and predicted values and ascertain the accuracy of the method. Each mock community consists of (A) known bacteria, whose 16S rRNA genes were used to filter out known bacteria, and (B) unknown bacteria, whose 16S rRNA genes must be identified and separated into different clusters representing different unknown bacteria.

These mock communities were synthetically created to evaluate various aspects of our method. In our experiments, short reads from 16S rRNA genes were generated using Grinder [22] using parameters for the Illumina sequencing platform. Mean read length was 150 with a standard deviation of 20. Read coverage was between 10x to 100x and the percentage of unknown bacteria varied from 1 to 16%. To study how one parameter affects the accuracy of the method, we used mock communities in which only that parameter varied while the others were kept constant.

The affect of coverage on prediction accuracy

First, we examined how the method’s accuracy (in terms of completeness, homogeneity, mutual information and Rand index) varied at increasing read coverages. We expected that having more reads means having more information and that would result in an observed increase in accuracy. In this experiment, read coverage in mock communities varied from 10x to 100x. The percentage of unknown bacteria in these communities were kept constant at 8%.

Figure 3 shows accuracies measured by 4 different metrics. As expected, prediction accuracy was higher at higher coverage for 3 of the measures. Additionally, accuracy values measured by AMI are generally higher than ARI. AMI tells us about the degree of randomness of a predicted clustering compared to the ground-truth clustering, whereas ARI attempts to quantify the item pairs that are in the same and different subsets. Our interpretation of this observation is that while predictions are not random, there are still structural information among clusters or within clusters that our method has not fully exploited.

Fig. 3
figure 3

Accuracy of predicting unknown bacteria (measured by 4 different metrics) at read coverage ranging from 10x to 100x

Further, predictions were homogeneous than complete. This means that (i) a cluster more likely contains only reads that belong to some bacterium, and (ii) reads belonging to a bacterium could be placed in multiple clusters. Observation (i) confirmed that the method worked as it should. To understand observation (ii), note that if reads belonging to a gene do not assemble into a contiguous sequence (due to low or non-uniformity of coverage), then reads belonging to the gene will be placed into multiple clusters.

Finally, as coverage approached 100x, clusters became less homogenous. This happened because having more reads increased the change of mistakenly placing reads into clusters representing different bacteria. In this experiment, 80x appears to be a good coverage.

The affect of unknown bacteria concentration

To study the affect of the amount of unknown bacteria has on prediction accuracy, we evaluated our method with mock communities in which percentage of unknown bacteria varied from 2 to 16%, while read coverage was kept constant at 40x with 10 random replicates at each percentage.

The result of this experiment is summarized in the box plot in Fig. 4. As expected, prediction accuracy (as measured by AMI, ARI and Completeness) tended to decrease with more unknown bacteria. On the other hand, homogeneity were not effected very much. The result shows that accuracy starts dropping dramatically when the concentration of unknown bacteria reaches 16%. We hope that future improvements can increase this number.

Fig. 4
figure 4

Accuracy of predicting unknown bacteria (measured by 4 different metrics) at different amount of unknown bacteria

Conclusions

Although it is known that 16S rRNA genes can be used to distinguish known bacteria, we demonstrated that only reads from these genes can be used to predict the number of unknown bacteria in oral microbial communities. Advantages include (i) a reduction in cost and computational processing, and (ii) the high conservation of 16S rRNA genes increases the chance of reference genetic materials being highly similar to those of bacteria in environments, which eliminates multiple sources of errors and challenges.

References

  1. 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(1):386.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  2. Segata N, Waldron L, Ballarini A, Narasimhan V, Jousson O, Huttenhower C. Metagenomic microbial community profiling using unique clade-specific marker genes. Nature methods. 2012; 9(8):811–4.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  3. Brady A, Salzberg SL. Phymm and phymmbl: metagenomic phylogenetic classification with interpolated markov models. Nature Methods. 2009; 6(9):673–6.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  4. Lindner MS, Renard BY. Metagenomic abundance estimation and diagnostic testing on species level. Nucleic Acids Res. 2013; 41(1):10–10.

    Article  Google Scholar 

  5. Meinicke P, Aßhauer KP, Lingner T. Mixture models for analysis of the taxonomic composition of metagenomes. Bioinformatics. 2011; 27(12):1618–24.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  6. Nalbantoglu OU, Way SF, Hinrichs SH, Sayood K. Raiphy: phylogenetic classification of metagenomics samples using iterative refinement of relative abundance index profiles. BMC Bioinformatics. 2011; 12(1):41.

    Article  PubMed  PubMed Central  Google Scholar 

  7. Ounit R, Wanamaker S, Close TJ, Lonardi S. Clark: fast and accurate classification of metagenomic and genomic sequences using discriminative k-mers. BMC Genomics. 2015; 16(1):236.

    Article  PubMed  PubMed Central  Google Scholar 

  8. Lindner MS, Renard BY. Metagenomic profiling of known and unknown microbes with microbegps. PloS ONE. 2015; 10(2):0117711.

    Article  Google Scholar 

  9. Muyzer G, De Waal EC, Uitterlinden AG. Profiling of complex microbial populations by denaturing gradient gel electrophoresis analysis of polymerase chain reaction-amplified genes coding for 16s rrna. Appl Environ Microbiol. 1993; 59(3):695–700.

    CAS  PubMed  PubMed Central  Google Scholar 

  10. Stackebrandt E, Goebel B. Taxonomic note: a place for dna-dna reassociation and 16s rrna sequence analysis in the present species definition in bacteriology. Int J Syst Evol Microbiol. 1994; 44(4):846–9.

    Article  CAS  Google Scholar 

  11. Langille MG, Zaneveld J, Caporaso JG, McDonald D, Knights D, Reyes JA, Clemente JC, Burkepile DE, Thurber RL, Knight R, Beiko RG. Predictive functional profiling of microbial communities using 16S rRNA marker gene sequences. Nature Biotechnol. 2013; 31(9):814–21.

    Article  CAS  Google Scholar 

  12. Langmead B, Salzberg SL. Fast gapped-read alignment with bowtie 2. Nat Methods. 2012; 9(4):357–9.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  13. Li H, Durbin R. Fast and accurate long-read alignment with Burrows–Wheeler transform. Bioinformatics. 2010; 26(5):589–95.

    Article  PubMed  PubMed Central  Google Scholar 

  14. Liu CM, Wong T, Wu E, Luo R, Yiu SM, Li Y, Wang B, Yu C, Chu X, Zhao K, et al.Soap3: ultra-fast gpu-based parallel alignment tool for short reads. Bioinformatics. 2012; 28(6):878–9.

    Article  CAS  PubMed  Google Scholar 

  15. Vo NS, Tran Q, Niraula N, Phan V. Randal: a randomized approach to aligning dna sequences to reference genomes. BMC Genomics. 2014; 15(5):2.

    Article  Google Scholar 

  16. Li H, Handsaker B, Wysoker A, Fennell T, Ruan J, Homer N, Marth G, Abecasis G, Durbin R, et al.The sequence alignment/map format and samtools. Bioinformatics. 2009; 25(16):2078–9.

    Article  PubMed  PubMed Central  Google Scholar 

  17. Galler BA, Fisher MJ. An improved equivalence algorithm. Commun ACM. 1964; 7(5):301–3.

    Article  Google Scholar 

  18. Lee VE, Ruan N, Jin R, Aggarwal C In: Aggarwal CC, Wang H, editors. A Survey of Algorithms for Dense Subgraph Discovery. Boston: Springer: 2010. p. 303–36.

  19. Vinh NX, Epps J, Bailey J. Information theoretic measures for clusterings comparison: Variants, properties, normalization and correction for chance. J Mach Learn Res. 2010; 11(Oct):2837–54.

    Google Scholar 

  20. Hubert L, Arabie P. Comparing partitions. J Classif. 1985; 2(1):193–218.

    Article  Google Scholar 

  21. Rosenberg A, Hirschberg J. V-measure: A conditional entropy-based external cluster evaluation measure. In: EMNLP-CoNLL: 2007. p. 410–20.

  22. Angly FE, Willner D, Rohwer F, Hugenholtz P, Tyson GW. Grinder: a versatile amplicon and shotgun sequence simulator. Nucleic Acids Res. 2012; 40(12):e94. doi:10.1093/nar/gks251.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

Download references

Acknowledgements

We would like to thank the editors and all anonymous reviewers for valuable suggestions and constructive comments.

Funding

Publication charges for this work were partially funded by NSF grant CCF-1320297 to VP.

Availability of data and materials

Data used in the article are publicly available. Analysis tools are available upon request.

About this supplement

This article has been published as part of BMC Bioinformatics Volume 18 Supplement 14, 2017: Proceedings of the 14th Annual MCBIOS conference. The full contents of the supplement are available online at https://bmcbioinformatics.biomedcentral.com/articles/supplements/volume-18-supplement-14.

Authors’ contributions

QT developed software and scripts for analyses; performed simulations and experiments. DP helped collected data and performed analyses. VP developed the theory, algorithms and designed the experiments. All authors read and approved the final manuscript.

Ethics approval and consent to participate

Not applicable.

Consent for publication

Not applicable.

Competing interests

The authors declare that they have no competing interests.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Vinhthuy Phan.

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

Tran, Q., Pham, DT. & Phan, V. Using 16S rRNA gene as marker to detect unknown bacteria in microbial communities. BMC Bioinformatics 18 (Suppl 14), 499 (2017). https://doi.org/10.1186/s12859-017-1901-8

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/s12859-017-1901-8

Keywords