Skip to main content
Microbial Genomics logoLink to Microbial Genomics
. 2016 Jan 19;2(1):e000044. doi: 10.1099/mgen.0.000044

SimBac: simulation of whole bacterial genomes with homologous recombination

Thomas Brown 1, Xavier Didelot 2, Daniel J Wilson 3,4,5, Nicola De Maio 3,4,
PMCID: PMC5049688  EMSID: EMS70024  PMID: 27713837

Abstract

Bacteria can exchange genetic material, or acquire genes found in the environment. This process, generally known as bacterial recombination, can have a strong impact on the evolution and phenotype of bacteria, for example causing the spread of antibiotic resistance across clades and species, but can also disrupt phylogenetic and transmission inferences. With the increasing affordability of whole genome sequencing, the need has emerged for an efficient simulator of bacterial evolution to test and compare methods for phylogenetic and population genetic inference, and for simulation-based estimation. We present SimBac, a whole-genome bacterial evolution simulator that is roughly two orders of magnitude faster than previous software and includes a more general model of bacterial evolution, allowing both within- and between-species homologous recombination. Since methods modelling bacterial recombination generally focus on only one of these two modes of recombination, the possibility to simulate both allows for a general and fair benchmarking. SimBac is available from https://github.com/tbrown91/SimBac and is distributed as open source under the terms of the GNU General Public Licence.

Keywords: bacterial evolution, bacterial genomics, bacterial recombination, coalescent simulation

Data Summary

SimBac, the software we developed to simulate genome-wide bacterial evolution, is distributed as open source under the terms of the GNU General Public Licence, and is available from GitHub (https://github.com/tbrown91/SimBac). A manual and examples of usage of SimBac are provided in the Supplementary Material.

Impact Statement

Sequencing technologies are revolutionizing microbiology, allowing researchers to investigate with great detail the genetic information in bacteria. This increasingly overwhelming amount of information requires adequate, efficient computer methods to be processed in reasonable time. One of the most important tasks performed by computer methods is simulating data, as this provides a means for testing hypotheses and checking the performance of other methods in extracting valuable information from data. Previous software specifically developed for simulating bacterial evolution is limited in applicability, having been conceived for limited data and biological phenomena. We present SimBac, a new simulator of bacterial evolution that can generate data for thousands of bacterial genomes about 100 times faster than previous methods. SimBac also includes a very general model of bacterial evolution that accounts for the fact that bacteria can exchange genetic material with each other, not only within the same population, but also across species boundaries. Thanks to these advancements in SimBac it will be possible to efficiently test hypotheses and estimate parameters comparing real and simulated bacterial data, to test the accuracy of bacterial genomic methods, and to fairly compare methods that make different assumptions regarding bacterial evolution.

Introduction

Whole-genome bacterial sequencing is rapidly gaining in popularity and replacing multilocus sequence typing (MLST) thanks to its fast and cost-effective provision of higher resolution genetic information (Didelot et al., 2012; Wilson, 2012). Computational algorithms that use genomic data to infer epidemiological, phylogeographic, phylodynamic and evolutive patterns are generally hampered by recombination (e.g. Schierup & Hein, 2000; Posada & Crandall, 2002; Hedge & Wilson, 2014), and recent years have seen a surge of methods that measure, identify and account for bacterial homologous recombination (e.g. Didelot & Falush, 2007; Marttinen et al., 2008, 2012; Didelot et al., 2010; Croucher et al., 2015; Didelot & Wilson, 2015).

Assessing and comparing the performance of different methods is complicated by the use of different models of recombination, in particular within-species recombination leading to phylogenetically discordant sites (e.g. Didelot et al., 2010) or between-species recombination leading to accumulation of substitutions on specific branches and genomic intervals (e.g. Didelot & Falush, 2007). Simulators of bacterial evolution are routinely used for parameter inference and hypothesis testing (Fearnhead et al., 2005; Fraser et al., 2005) and for method testing and comparison (Falush et al., 2006; Didelot & Falush, 2007; Turner et al., 2007, Buckee et al., 2008; Wilson et al., 2009; Hedge & Wilson, 2014), but simulation software and models used are generally targeted to the specific model of evolution implemented in the methods considered. One of the reasons for this is the lack of general and efficient simulators of bacterial evolution.

Coalescent simulators of eukaryotic evolution usually focus on crossover recombination (see e.g. Arenas & Posada, 2007, 2010, 2014), while bacterial recombination is generally modelled as gene conversion, meaning that in a recombination event only a small fragment of DNA is imported from a donor, whereas most of the genetic material is inherited from the recipient. Many fast and approximate simulation methods (e.g. Marjoram & Wall, 2006; Excoffier & Foll, 2011) cannot be applied to bacterial recombination because the approximations used do not generate the expected long genomic distance correlations in bacterial local trees. Other similar approximate methods are only adequate for low bacterial recombination rates (e.g. Chen et al., 2009; Wang et al., 2014). Many forward-in-time simulation methods (e.g. Chadeau-Hyam et al., 2008; Dalquen et al., 2012) or discrete generation coalescent methods (Excoffier et al., 2000; Laval & Excoffier, 2004) can allow gene conversion, but are generally too slow for simulating whole-genome evolution of large samples or populations.

An exact and fast method to simulate gene conversion is the coalescent model of Wiuf & Hein (2000) included in ms (Hudson, 2002) and its extensions (Mailund et al., 2005; Hellenthal & Stephens, 2007; Ramos-Onsins & Mitchell-Olds 2007). Recently, this model has been implemented in simulation software specific for bacterial evolution, SimMLST (Didelot et al., 2009).

SimMLST is optimized for MLST data which requires to simulate several short distant loci, and, similarly to ms, only simulates within-species bacterial recombination. For these reasons, these methods are not generally suited for large, genome-wide bacterial simulation studies or for testing different models and assumptions of recombination.

Here we present SimBac, a new method for simulating bacterial evolution. SimBac implements an efficient coalescent-based algorithm for simulating genome-wide bacterial evolution, and includes a new and more general model of bacterial recombination that extends the classical within-species recombination (Didelot et al., 2009) by allowing the user to specify any degree of recombination between species.

Theory and Implementation

We simulate evolution backward in time under the standard coalescent model with gene conversion, and generate an ancestral recombination graph (ARG; see Wiuf & Hein, 2000). Within-species recombination events are modelled as a copy-pasting of a small fragment of DNA from the donor lineage sequence into the recipient.

The computational efficiency of SimBac derives from algorithmic improvements over previous software. First, instead of rejection sampling of recombination events as described by Didelot et al. (2009), we developed an analytical solution that only samples recombination events effectively altering ancestral material of lineages (details of the methods are available in the online Supplementary Material). Second, we represent ancestral material with a more efficient data structure. These new features allow about 100-fold faster simulation of bacterial genome-wide evolution compared with SimMLST (see Fig. 1). Also, our method generally outperforms ms (Hudson, 2002) when many recombination (or equivalently gene conversion) events are expected.

Fig. 1.

Fig. 1

Comparison of run-time of SimMLST, ms and SimBac. Only gene conversion (no crossover) is simulated in ms, to model bacterial evolution. (a) Mean time to simulate the ARG for a fixed recombination rate R = 0.01 and genome length from 100 bp to 1 Mbp. (b) Mean time to simulate the ARG for a fixed genome length of 1 Mbp and recombination rate increasing from R = 0 to R = 0.05. One hundred simulations were performed for each dot, except for SimMLST at R = 0.02 and R = 0.05, and ms at R = 0.02, where 10 simulations were performed due to the elevated computational demand. ms was not run at R = 0.05 because a single run required >4 days. Error bars show ± 1 sd.

Our software also provides the possibility to simulate a circular or linear genome, and entire or fragmented bacterial genome, and offers a recombination model that allows a mixture of between- and within-species recombination. Within-species recombination is modelled as the coalescent with gene conversion (Wiuf & Hein, 2000; Didelot et al., 2009) with fragment lengths distributed geometrically with mean δ, and with all sites having the same per-site recombination initiation rate R (scaled by the effective population size). As the coalescent process is simulated backward in time, any extant lineage can be the recipient of a recombining interval from a donor lineage, which is then added to the other extant lineages. In such a case, the recombining interval becomes part of the genome of the new donor lineage (see Fig. 2b). Every site of the genome of every extant lineage becomes the start of a recombining interval at the same rate R.

Fig. 2.

Fig. 2

Examples of ancestral recombination graphs (ARGs) generated and plotted by SimBac. Branches represent ARG lineages, and time is considered to go backward from the bottom to the top of the tree. Branch merges (from bottom to top) represent coalescent events, while branch splits represent recombination events. (a) Example ARG with the clonal frame lineages marked in black, the non-clonal lineages in grey, and a recombination event involving an external species marked in red. (b) Same ARG as before, but with ancestral material of each lineage represented as a rectangle in the corresponding node. Each coloured vertical bar inside each rectangle represent a genomic segment. Genomic segments that are present in the ancestral material are coloured in grey, those absent are in white, and those imported from an external species are in red.

Between-species recombination is modelled as a separate process backward in time with a specific scaled per-site recombination initiation rate Re and a specific distribution of imported fragment lengths (geometric with mean δe). When a between-species recombination event occurs at a recipient lineage and interval, the donor lineage is not tracked back in time as for within-species recombination, but instead substitutions are introduced into the recombining interval, similar to the model in ClonalFrame (Didelot & Falush, 2007). Therefore, we do not simulate species evolution as described by Arenas & Posada (2014), but rather assume that each recombining segment is donated by a different lineage within a given divergence range.

However, differently from ClonalFrame, the donor sequence is obtained by adding a random amount of divergence [uniformly sampled within the interval (D1, D2), specified by the user] into the corresponding homologous sequence from the root of the ARG. This model accounts for the excess of substitutions caused by between-species recombination as in ClonalFrame, but at the same time also generates the homoplasies that are expected if the recipient lineage does not lead to the root of the local tree. More details on the methods of simulation and a summary of the algorithm are provided in the online Supplementary Material.

To showcase the possible applications of our software, we extend the investigation of phylogenetic inference accuracy by Hedge & Wilson (2014). The authors investigated the effect of low bacterial recombination rates (up to a scaled per-site rate of R = 0.01) on the inference of clonal frame. Using SimBac, we are able to simulate higher recombination rates (up to R = 0.1) in reasonable time, and we show that for highly recombining bacteria, and in particular for older phylogenetic branches, the probability of reconstructing the phylogenetic topology is reduced further to around 91 % (Fig. 3).

Fig. 3.

Fig. 3

Accuracy of clonal frame estimation from recombining bacterial genomes. The x-axis shows the recombination rate R under which simulations are performed. The y-axis shows the accuracy of inference, as the proportion of branches correctly estimated using the Robinson–Foulds metric (Robinson & Foulds, 1981). Ten independent replicates are used for R = 0.1 and 100 in all other cases. Genomes are 1 Mbp long and the scaled mutation rate is fixed at 0.01. (a) Accuracy of three phylogenetic methods: neighbour-joining (NJ), unweighted pair group method with arithmetic mean (UPGMA) and maximum-likelihood (ML). Error bars represent ± 1 sd. (b) Clonal frame branches were separated into three age categories: young, middle-aged and old (respectively with a distance between the branch mid-point and the root of more than 2.09, between 1.32 and 2.09, and less than 1.32 Ne generations). The ML accuracy for each age category is plotted separately in different colours.

Conclusion

Simulation of genome evolution is important as it allows inference of parameters from data and testing of evolutionary hypotheses, and because it is routinely used to benchmark and compare different microbial genomic analysis methods. We present SimBac, a new method for simulating genome-wide bacterial evolution implemented and distributed as open source software (https://github.com/tbrown91/SimBac). Our model of bacterial recombination is more general than those used by most methods in the field, in that it can describe any mixture of within-species and between-species recombination, and as such, it can fit the assumptions of most methods, or it can provide a more realistic background for comparing methods with different hypotheses.

Also, our efficient implementation achieves an approximately 100-fold increase in computational efficiency over previous similar efforts, allowing inference and benchmarking over considerably larger datasets. For example, 1000 1 Mbp genomes with R = 0.01 can be generated in about 6 min. SimBac can generate a wide range of possible outputs: sequence alignments, ARGs graphics (see Fig. 2), clonal frames, local genealogies and lists of recombination events. Although only a Jukes & Cantor substitution model (Jukes & Cantor 1969) is presently included in SimBac, in practice this is not a restriction because the local genealogies can be used to generate alignments under a vast choice of nucleotide and codon substitution models using, for example, SeqGen (Rambaut & Grassly, 1997) or INDELible (Fletcher & Yang, 2009) (see Arenas, 2013).

Although SimBac generalizes the applicability of SimMLST, it currently lacks the wide set of options of some simulators of evolution, in particular of forward simulators that allow very general demographic, speciation, selection, migration and rate variation patterns (e.g. Chadeau-Hyam et al., 2008; Dalquen et al., 2012). In fact, many of these features present considerable methodological hurdles in being incorporated in computationally efficient coalescent simulators.

Yet, future extensions of our method could consist of the inclusion of distributive conjugal transfer (Gray et al., 2013), of non-homogeneous genomic rates of recombination (see e.g. Everitt et al., 2014; Arenas & Posada, 2014), or of demographic events and population structure (Arenas & Posada, 2007, 2014).

Acknowledgements

This work was supported by the Engineering and Physical Sciences Research Council (EP/F500394/1 to T. B.); the Biotechnology and Biological Sciences Research Council (BB/L023458/1 to X. D.); the National Institute for Health Research (HPRU-2012-10080 to X. D.); the Wellcome Trust to D. J. W.; the Royal Society (101237/Z/13/Z to D. J. W.); and the Oxford Martin School to N. D. M. We thank Jessica Hedge for comments on the project.

Supplementary Data

Supplementary Data

Abbreviations:

ARG

ancestral recombination graph

MLST

multilocus sequence typing

References

  1. Arenas M. (2013). Computer programs and methodologies for the simulation of DNA sequence data with recombination Front Genet 49. 10.3389/fgene.2013.00009. [DOI] [PMC free article] [PubMed] [Google Scholar]
  2. Arenas M., Posada D. (2007). Recodon: coalescent simulation of coding DNA sequences with recombination, migration and demography BMC Bioinformatics 8458. 10.1186/1471-2105-8-458. [DOI] [PMC free article] [PubMed] [Google Scholar]
  3. Arenas M., Posada D. (2010). Coalescent simulation of intracodon recombination Genetics 184429–437 10.1534/genetics.109.109736. [DOI] [PMC free article] [PubMed] [Google Scholar]
  4. Arenas M., Posada D. (2014). Simulation of genome-wide evolution under heterogeneous substitution models and complex multispecies coalescent histories Mol Biol Evol 311295–1301 10.1093/molbev/msu078. [DOI] [PMC free article] [PubMed] [Google Scholar]
  5. Buckee C. O., Jolley K. A., Recker M., Penman B., Kriz P., Gupta S., Maiden M. C. (2008). Role of selection in the emergence of lineages and the evolution of virulence in Neisseria meningitidis Proc Natl Acad Sci U S A 10515082–15087 10.1073/pnas.0712019105. [DOI] [PMC free article] [PubMed] [Google Scholar]
  6. Chadeau-Hyam M., Hoggart C. J., O'Reilly P. F., Whittaker J. C., De Iorio M., Balding D. J. (2008). Fregene: simulation of realistic sequence-level data in populations and ascertained samples BMC Bioinformatics 9364. 10.1186/1471-2105-9-364. [DOI] [PMC free article] [PubMed] [Google Scholar]
  7. Chen G. K., Marjoram P., Wall J. D. (2009). Fast and flexible simulation of DNA sequence data Genome Res 19136–142 10.1101/gr.083634.108. [DOI] [PMC free article] [PubMed] [Google Scholar]
  8. Croucher N. J., Page A. J., Connor T. R., Delaney A. J., Keane J. A., Bentley S. D., Parkhill J., Harris S. R. (2015). Rapid phylogenetic analysis of large samples of recombinant bacterial whole genome sequences using Gubbins Nucleic Acids Res 43e15. 10.1093/nar/gku1196. [DOI] [PMC free article] [PubMed] [Google Scholar]
  9. Dalquen D. A., Anisimova M., Gonnet G. H., Dessimoz C. (2012). ALF—a simulation framework for genome evolution Mol Biol Evol 291115–1123 10.1093/molbev/msr268. [DOI] [PMC free article] [PubMed] [Google Scholar]
  10. Didelot X., Falush D. (2007). Inference of bacterial microevolution using multilocus sequence data Genetics 1751251–1266 10.1534/genetics.106.063305. [DOI] [PMC free article] [PubMed] [Google Scholar]
  11. Didelot X., Wilson D. J. (2015). ClonalFrameML: efficient inference of recombination in whole bacterial genomes PLOS Comput Biol 11e1004041. 10.1371/journal.pcbi.1004041. [DOI] [PMC free article] [PubMed] [Google Scholar]
  12. Didelot X., Lawson D., Falush D. (2009). SimMLST: simulation of multi-locus sequence typing data under a neutral model Bioinformatics 251442–1444 10.1093/bioinformatics/btp145. [DOI] [PubMed] [Google Scholar]
  13. Didelot X., Lawson D., Darling A., Falush D. (2010). Inference of homologous recombination in bacteria using whole-genome sequences Genetics 1861435–1449 10.1534/genetics.110.120121. [DOI] [PMC free article] [PubMed] [Google Scholar]
  14. Didelot X., Bowden R., Wilson D. J., Peto T. E., Crook D. W. (2012). Transforming clinical microbiology with bacterial genome sequencing Nat Rev Genet 13601–612 10.1038/nrg3226. [DOI] [PMC free article] [PubMed] [Google Scholar]
  15. Everitt R. G., Didelot X., Batty E. M., Miller R. R., Knox K., Young B. C., Bowden R., Auton A., Votintseva A., other authors (2014). Mobile elements drive recombination hotspots in the core genome of Staphylococcus aureus Nat Commun 53956. 10.1038/ncomms4956. [DOI] [PMC free article] [PubMed] [Google Scholar]
  16. Excoffier L., Foll M. (2011). fastsimcoal: a continuous-time coalescent simulator of genomic diversity under arbitrarily complex evolutionary scenarios Bioinformatics 271332–1334 10.1093/bioinformatics/btr124. [DOI] [PubMed] [Google Scholar]
  17. Excoffier L., Novembre J., Schneider S. (2000). simcoal: a general coalescent program for the simulation of molecular data in interconnected populations with arbitrary demography J Hered 91506–509 10.1093/jhered/91.6.506. [DOI] [PubMed] [Google Scholar]
  18. Falush D., Torpdahl M., Didelot X., Conrad D. F., Wilson D. J., Achtman M. (2006). Mismatch induced speciation in Salmonella: model and data Philos Trans R Soc Lond B Biol Sci 3612045–2053 10.1098/rstb.2006.1925. [DOI] [PMC free article] [PubMed] [Google Scholar]
  19. Fearnhead P., Smith N. G., Barrigas M., Fox A., French N. (2005). Analysis of recombination in Campylobacter jejuni from MLST population data J Mol Evol 61333–340 10.1007/s00239-004-0316-0. [DOI] [PubMed] [Google Scholar]
  20. Fletcher W., Yang Z. (2009). INDELible: a flexible simulator of biological sequence evolution Mol Biol Evol 261879–1888 10.1093/molbev/msp098. [DOI] [PMC free article] [PubMed] [Google Scholar]
  21. Fraser C., Hanage W. P., Spratt B. G. (2005). Neutral microepidemic evolution of bacterial pathogens Proc Natl Acad Sci U S A 1021968–1973 10.1073/pnas.0406993102. [DOI] [PMC free article] [PubMed] [Google Scholar]
  22. Gray T. A., Krywy J. A., Harold J., Palumbo M. J., Derbyshire K. M. (2013). Distributive conjugal transfer in mycobacteria generates progeny with meiotic-like genome-wide mosaicism, allowing mapping of a mating identity locus PLoS Biol 11e1001602. 10.1371/journal.pbio.1001602. [DOI] [PMC free article] [PubMed] [Google Scholar]
  23. Hedge J., Wilson D. J. (2014). Bacterial phylogenetic reconstruction from whole genomes is robust to recombination but demographic inference is not MBio 5e02158–e02114 10.1128/mBio.02158-14. [DOI] [PMC free article] [PubMed] [Google Scholar]
  24. Hellenthal G., Stephens M. (2007). msHOT: modifying Hudson's ms simulator to incorporate crossover and gene conversion hotspots Bioinformatics 23520–521 10.1093/bioinformatics/btl622. [DOI] [PubMed] [Google Scholar]
  25. Hudson R. R. (2002). Generating samples under a Wright-Fisher neutral model of genetic variation Bioinformatics 18337–338 10.1093/bioinformatics/18.2.337. [DOI] [PubMed] [Google Scholar]
  26. Jukes T. H., Cantor C. R. (1969). Evolution of protein molecules. In Mammalian Protein Metabolism 3, pp. 21–132. Edited by Munro H. N.New York: Academic Press; 10.1016/B978-1-4832-3211-9.50009-7. [DOI] [Google Scholar]
  27. Laval G., Excoffier L. (2004). simcoal 2.0: a program to simulate genomic diversity over large recombining regions in a subdivided population with a complex history Bioinformatics 202485–2487 10.1093/bioinformatics/bth264. [DOI] [PubMed] [Google Scholar]
  28. Mailund T., Schierup M. H., Pedersen C. N., Mechlenborg P. J., Madsen J. N., Schauser L. (2005). CoaSim: a flexible environment for simulating genetic data under coalescent models BMC Bioinformatics 6252. 10.1186/1471-2105-6-252. [DOI] [PMC free article] [PubMed] [Google Scholar]
  29. Marjoram P., Wall J. D. (2006). Fast coalescent simulation BMC Genet 716. [DOI] [PMC free article] [PubMed] [Google Scholar]
  30. Marttinen P., Baldwin A., Hanage W. P., Dowson C., Mahenthiralingam E., Corander J. (2008). Bayesian modeling of recombination events in bacterial populations BMC Bioinformatics 9421. [DOI] [PMC free article] [PubMed] [Google Scholar]
  31. Marttinen P., Hanage W. P., Croucher N. J., Connor T. R., Harris S. R., Bentley S. D., Corander J. (2012). Detection of recombination events in bacterial genomes from large population samples Nucleic Acids Res 40e6. 10.1093/nar/gkr928. [DOI] [PMC free article] [PubMed] [Google Scholar]
  32. Posada D., Crandall K. A. (2002). The effect of recombination on the accuracy of phylogeny estimation J Mol Evol 54396–402 10.1007/s00239-001-0034-9. [DOI] [PubMed] [Google Scholar]
  33. Rambaut A., Grassly N. C. (1997). Seq-Gen: an application for the Monte Carlo simulation of DNA sequence evolution along phylogenetic trees Comput Appl Biosci 13235–238. [DOI] [PubMed] [Google Scholar]
  34. Ramos-Onsins S. E., Mitchell-Olds T. (2007). Mlcoalsim: multilocus coalescent simulations Evol Bioinform Online 341–44. [PMC free article] [PubMed] [Google Scholar]
  35. Robinson D., Foulds L. R. (1981). Comparison of phylogenetic trees Math Biosci 53131–147 10.1016/0025-5564(81)90043-2. [DOI] [Google Scholar]
  36. Schierup M. H., Hein J. (2000). Consequences of recombination on traditional phylogenetic analysis Genetics 156879–891. [DOI] [PMC free article] [PubMed] [Google Scholar]
  37. Turner K. M., Hanage W. P., Fraser C., Connor T. R., Spratt B. G. (2007). Assessing the reliability of eBURST using simulated populations with known ancestry BMC Microbiol 730. 10.1186/1471-2180-7-30. [DOI] [PMC free article] [PubMed] [Google Scholar]
  38. Wang Y., Zhou Y., Li L., Chen X., Liu Y., Ma Z. M., Xu S. (2014). A new method for modeling coalescent processes with recombination BMC Bioinformatics 15273. 10.1186/1471-2105-15-273. [DOI] [PMC free article] [PubMed] [Google Scholar]
  39. Wilson D. J. (2012). Insights from genomics into bacterial pathogen populations PLoS Pathog 8e1002874. 10.1371/journal.ppat.1002874. [DOI] [PMC free article] [PubMed] [Google Scholar]
  40. Wilson D. J., Gabriel E., Leatherbarrow A. J., Cheesbrough J., Gee S., Bolton E., Fox A., Hart C. A., Diggle P. J., Fearnhead P. (2009). Rapid evolution and the importance of recombination to the gastroenteric pathogen Campylobacter jejuni Mol Biol Evol 26385–397 10.1093/molbev/msn264. [DOI] [PMC free article] [PubMed] [Google Scholar]
  41. Wiuf C., Hein J. (2000). The coalescent with gene conversion Genetics 155451–462. [DOI] [PMC free article] [PubMed] [Google Scholar]

Data Bibliography

Associated Data

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

Supplementary Materials

Supplementary Data


Articles from Microbial Genomics are provided here courtesy of Microbiology Society

RESOURCES