Skip to main content
  • Technical Note
  • Open access
  • Published:

De novo assembly of Dekkera bruxellensis: a multi technology approach using short and long-read sequencing and optical mapping

Abstract

Background

It remains a challenge to perform de novo assembly using next-generation sequencing (NGS). Despite the availability of multiple sequencing technologies and tools (e.g., assemblers) it is still difficult to assemble new genomes at chromosome resolution (i.e., one sequence per chromosome). Obtaining high quality draft assemblies is extremely important in the case of yeast genomes to better characterise major events in their evolutionary history. The aim of this work is two-fold: on the one hand we want to show how combining different and somewhat complementary technologies is key to improving assembly quality and correctness, and on the other hand we present a de novo assembly pipeline we believe to be beneficial to core facility bioinformaticians. To demonstrate both the effectiveness of combining technologies and the simplicity of the pipeline, here we present the results obtained using the Dekkera bruxellensis genome.

Methods

In this work we used short-read Illumina data and long-read PacBio data combined with the extreme long-range information from OpGen optical maps in the task of de novo genome assembly and finishing. Moreover, we developed NouGAT, a semi-automated pipeline for read-preprocessing, de novo assembly and assembly evaluation, which was instrumental for this work.

Results

We obtained a high quality draft assembly of a yeast genome, resolved on a chromosomal level. Furthermore, this assembly was corrected for mis-assembly errors as demonstrated by resolving a large collapsed repeat and by receiving higher scores by assembly evaluation tools. With the inclusion of PacBio data we were able to fill about 5 % of the optical mapped genome not covered by the Illumina data.

Peer Review reports

Background

In the last decade we have witnessed an unprecedented development in sequencing technologies. This is sometimes referred to as the next-generation sequencing (NGS) revolution. Year by year, new technologies and chemistries have, to varying degrees, enabled increased throughput, read lengths and sequence quality. Currently there is a wide range of technologies and companies that allow sequencing and genomics analysis at a speed and with a throughput thought impossible only few years ago. In this work we focus our attention on three established technologies and their compatible tools: Illumina [1], PacBio [2] and OpGen [3]. However, the methods presented here can easily be extended and applied to similar and/or emerging technologies, e.g., IonTorrent [4], Oxford Nanopore [5] and BioNano [6]. The Illumina sequencing technology has become a leading tool in a wide range of application areas. Among others, Illumina is used for whole genome resequencing, haplotype phasing and identification of structural variations. Illumina technology is also widely used in de novo genome assembly projects. Despite the short read length, Illumina is used to quickly and cheaply obtain high genome coverages [7].

In 2011 Pacific Biosciences released the first commercially available long-read sequencer based on single-molecule real-time (SMRT) sequencing technology. In contrast to the short (i.e., 150 to 300 bp) Illumina reads, the PacBio RS II instrument produces average read lengths ranging from 10–15 kb, with the ultra-long reads exceeding 50 kb. Such unprecedented read lengths are ideal for de novo assembly. However, long reads are also a key in studying structural variations or investigating isoforms by sequencing full-length intact transcripts [8–11].

Another technology is optical mapping [12–16], a method based on mapping the position of enzyme restriction sites along the sequence of the genome as observed by fluorescence microscopy, which was automated [17, 18] to achieve high-throughput solutions amenable to the analysis of complex genomes. This technique allows the production of extremely long (hundreds of kbp) restriction maps, which to date has been applied to, e.g., alignment to a reference sequence to identify structural variations in bacteria [19–22] and in humans [23–25]. In the field of de novo assembly, whole genome mapping has been used for scaffolding prokaryote assemblies [26, 27] and a fungus assembly [28], but also assemblies of complex eukaryotes such as the domestic goat [29] and maize [30]. Optical mapping was also used for refining the mouse reference genome [31].

Yeasts are unicellular fungi, with a high diversity and a high phylogenetic distance. They are essential for a number of biotechnological applications, for the functioning of natural ecosystems or can act as human and animal pathogens [32, 33]. Since they have relatively small and compact genomes they are also ideal model organisms to study eukaryotic genome evolution. Indeed, the first sequenced eukaryotic organism was the yeast Saccharomyces cerevisiae in 1996 [34]. In 2010, about 40 yeast species had been sequenced and reported [32]. After the establishment of NGS, the number of sequenced yeast genomes rapidly increased, and today, for some yeast species, the intraspecific genome diversity between strains can be determined [33, 35–37]. However, short-read draft assemblies are often comprised of hundreds of unsorted and disordered contigs. This makes it very difficult, or impossible, to investigate chromosome rearrangements such as inversions, duplications or chromosomal translocations, which play an important role in fungal evolution [32]. Moreover, pulsed field gel electrophoresis studies have shown considerable chromosome polymorphisms among strains of fungal species [38–41], thus making de novo assembly a much more difficult and complex task.

In this work we will show how combining multiple technologies in a de novo sequencing project – in effect exploiting their individual strengths – is an optimal strategy to improve the quality of the resulting assembly. In doing so we will perform an extensive validation of obtained assemblies. As a by product, we also present a semi-automated de novo assembly pipeline, dubbed ‘NouGAT’, which was instrumental to this work. This pipeline is currently in use at the National Genomic Infrastructure hosted at SciLifeLab in Stockholm to assemble hundreds of genomes every year. As a proof-of-concept, we applied our approach to carry out a de novo assembly of the yeast genome, Dekkera bruxellensis.

Methods

De novo assembly pipeline

We describe a semi-automated de novo assembly pipeline dubbed NouGAT [42], developed at the National Genomics Infrastructure (NGI) at SciLifeLab in Sweden. The aim of this tool is to easily (i) pre-process the sequencing data, (ii) assemble input data in a semi-automated way, (iii) evaluate and rank assemblies, and (iv) use information from optical maps to improve the quality of the draft assembly. NouGAT’s design is based on the findings of the Assemblathon 1 and 2 challenges [43, 44], and by the evaluation study GAGE [45]. Below we demonstrate NouGAT, by assembling the genome of D. bruxellensis, (see Fig. 1).

Fig. 1
figure 1

Bioinformatic workflow overview. There were three entry points of data, shown by boxes with white shading: Illumina read data, PacBio read data and OpGen optical map data. Boxes shaded in dark blue show work done by the assembly pipeline in a semi-automated fashion: quality control (and trimming) of short-read Illumina data, Illumina-only assemblers, evaluation of assembly quality (for all assemblies) using feature-response curves and standard metrics, preparing two chosen assemblies for in silico digestion and optical map placement and finally using open_util.py to generate an assembly from the scaffold-optical map placement coordinates. Work done outside the assembly pipeline is shown as boxes with light blue shading: the PacBio-only assemblies, the PacBio-Illumina hybrid assemblies and the operation of OpGen’s Mapsolver software for in silico digestion and placement of scaffolds and their placement on optical maps

Pre-processing of reads is of great importance for assembly quality, as previously demonstrated by the GAGE study [45]. It is also essential to assess the quality of the reads to spot problems in the steps prior to assembly, e.g., DNA extraction, library construction and sequencing. For short-read data, the pipeline uses Trimmomatic [46] for removing adapter contamination and low quality regions. This has been shown to prevent the generation of adapter-chimeric contigs and to increase assembly contiguity [46]. Using the trimmed reads as input, the pipeline plots the k-mer abundance as generated by ABySS [47] and the quality metrics generated by FastQC [48].

The assembly sub-pipeline is created to enable a variety of assembly programs to be run. As previously shown in the Assemblathon and GAGE studies, different assemblers can result in completely different assembly qualities. However, the large number of assemblers, and the large number of user-definable parameters, can make this a difficult task. NouGAT allows the user to run a number of assemblers (seven are currently supported) by specifying a single configuration file. Currently only Illumina-only assemblers are supported, but ongoing work is in progress to extend this subpipeline to PacBio and hybrid assemblers.

For evaluating assemblies, the standard contiguity and size metrics (e.g., N50, average contig size, etc.) may give a false representation of its correctness [49]. As an example, an assembly composed of few but very long contigs (i.e., a highly connected assembly) might not always be the best representation of the underlying genome [45] because longer contigs could be the results of a too-eager assembly strategy. A handful of tools exists to gauge assembly quality and correctness on the basis of more reliable metrics [49–51]. The majority of these tools try to reconstruct the read layout and to identify areas of the assembly that are likely to contain mis-assemblies. We decided to employ feature-response curves (FRC) [49]. FRC uses anomalously mapped paired-end and mate-pair reads to identify suspicious areas, called features. Subsequently, features are tallied for each contig, along with the estimated contig genomic coverages. These points are ordered by decreasing contig size and plotted by accumulating the number of features. The resulting plot is, in some aspects, similar to a receiver operating characteristic (ROC), where the assembly with the steepest curve is likely to contain fewer mis-assemblies.

The strategy for assembly refinement using optical maps is to select the two best performing assemblies and place their contigs on the optical maps. This entails manual curation using OpGen’s Mapsolver software. Subsequently, a consensus sequence is generated for each assembled optical map using a utility script found in NouGAT.

Results

De novo assembly

A total of seven assemblies were generated using Illumina and PacBio sequencing data (for a summary of computational resources used see Additional file 1: Table S4). We used these two data sets both in isolation and combined. To generate assemblies from only Illumina reads, we used ALLPATHS-LG [52], ABySS [47], and SOAPdenovo [53]. For assembly of PacBio reads only, HGAP [8] and FALCON [54] were used. Illumina-PacBio hybrid assemblies were generated by AHA [55] and CABOG (using pacBioToCA error correction by Illumina reads) [56]. For assemblers using a De Bruijn Graph method with a mandatory k-mer size parameter (ABySS and SOAPdenovo), we tested a range of k when running SOAPdenovo, and found k = 61 to be optimal (see Additional file 1).

We computed standard contiguity metrics (Table 1) for all assemblies. Table 1 shows that ALLPATHS-LG gave the most well connected Illumina assembly, i.e., greater N50 and fewer but longer contigs. In comparison, the ABySS assembly had the lowest N50 number and more numerous but shorter contigs. In terms of N50, the SOAPdenovo assembly can be regarded as being better connected than the ABySS assembly; however, a large majority of the assembly consists of contigs less than 1 kbp in length. When considering PacBio only assemblies, the most connected assembly is the one produced by HGAP, which has an N50 four times shorter than that produced by ALLPATHS-LG. FALCON performed noticeably worse than HGAP, with a much lower assembly length (see Table 1) and a lower N50. However, FALCON is experimental and might not be suitable for the input data, and/or it was used with non-optimal parameters. AHA fared best among the hybrid-assemblies.

Table 1 Standard contiguity metrics

In the absence of a reference sequence, it is difficult, if not impossible, to determine the assembly that is most representative for the underlying genome based on the standard contiguity metrics alone. We ran CEGMA on all assemblies to evaluate their gene space (see Fig. 5 and section below for more details). However, CEGMA only helped us to identify SOAPdenovo, FALCON, and AHA as outliers. The remaining five assemblies contained a similar number of core genes. We decided to use FRC analysis to evaluate our assemblies, used in a similar way to that used for the Norway spruce genome [7] and GAM-NGS studies [57]. The cumulative feature curves (Fig. 2) confirmed the poor performance of the less connected assemblies produced by ABySS and FALCON. FRC did, however, overturn the contiguity metrics for most connected assemblies: ALLPATHS-LG and HGAP. FRC also reshaped the order of PacBio assemblers pacBioToCa and HGAP. ALLPATHS-LG was not only the best Illumina assembler, but also generated the assembly with fewest features, i.e., areas of suspected mis-assembly. However, Fig. 2 shows that HGAP was able to cover more of the genome while introducing fewer features. Clearly, the long ALLPATHS-LG contigs accumulate more features than the shorter HGAP contigs, e.g., with 2000 features we were able to cover more than 60 % of HGAP assembly but ‘only’ 50 % of that assembled by ALLPATH-LG. This might suggest that the long ALLPATH-LG contigs are the result of a too-eager assembly strategy (see Fig. 3 and Additional file 1: Figure S2). Remarkably AHA, one of the better connected assemblies, performed much worse than pacBioToCA because of it had a high number of compressed repeat features (Additional file 1: Figure S3).

Fig. 2
figure 2

Feature response curves. Feature response curves (FRC) for assemblies considered for optical map placement. On the x-axis is the total number of features normalised for the assembly contig count. On the y-axis is the coverage based on the estimated genome size of 14,719,721 bp (size of the first completed assembly, HGAP)

Fig. 3
figure 3

Placement of ap_contig1 to optical map Chromosome 1. An illustration re-drawn from the output of the OpGen’s Mapsolver software, where in silico digested allpaths-lg contigs are placed to the optical map Chromosome 1. It shows a complex rearrangement where flaws in the allpaths-lg assembly are corrected. The 1.38 Mbp region A´ of ap_contig1 is a collapsed repeat structure, which the optical map was able to resolve and subsequently could be placed to regions a 1 and a 2 of Chromosome 1. This map placement is highlighted in transparent red for clarity and shows that the sequences were placed in inversed orientation. Furthermore, a 2 and a 3 are flanking the placed sequence b 1 , originating from the B region of the contig ap_contig6. On the left flank of B is an unplaced region whose restriction enzyme cuts could not be aligned to the cuts made by the Argus system, and is likely the result of mis-assembly

After a careful analysis of contiguity metrics, CEGMA hits, FRC curves, and coverage plots (Additional file 1: Figure S4 and S5) automatically produced by the NouGAT, we deemed ALLPATHS-LG and HGAP to have produced the best assemblies. Consequently, we chose them for optical map placement.

Optical map placement

From the OpGen imaging and data processing steps, seven optical maps were obtained, named Chromosome 1, Chromosome 2, etc., spanning about 16.79 Mbp in total. This is an impressive result compared with the 308 and 351 unordered contigs generated by HGAP and ALLPATHS-LG, and with this critical information we were able to both spatially resolve the D. bruxellensis genome and to error correct de novo assembled contigs. Using OpGen’s MapSolver software to digest in silico assembled sequences and placement on optical maps, we devised the following strategy: first cover the maps using ALLPATHS-LG contigs of minimum 40 kbp length (shorter fragments cannot be placed as they do not have enough in silico restriction enzyme cuts), and then fill in any remaining gaps using HGAP assembled contigs. Using this method we were able to cover 87 % with contigs, with the remaining unplaced ALLPATHS-LG contigs included as ‘unknown’ sequences.

An interesting feature of note is represented in Fig. 3. In this figure we can clearly appreciate the potentiality of optical mapping when it comes to finishing and error correcting draft assemblies. Chromosome 1 has been assembled to a single restriction map using optical mapping. The figure represents a complex repeat structure, shown schematically as three sequences labelled a1, a2, b1, and a3, with a2 and a3 containing an identical repeat the size of approximately 434 kbp. Thanks to the longer fragment lengths utilised by this method, a complex repeat structure has been resolved (contained in regions a2 and a3). Neither ALLPATHS-LG nor HGAP (i.e., neither Illumina nor PacBio) alone has been able to correctly reconstruct such a complex scenario. HGAP resulted in 13 small contigs partially covering regions a 2 and a 3 , one of which is placed in both (see Additional file 1: Figure S2). ALLPATHS-LG has been able to produce an extremely long contig, likely using the information inferred from the longest mate-pair library. However, Fig. 3 clearly demonstrates that the long contig, ap_contig1, is the result of wrong decisions made during scaffolding; not only that a complex repeat is collapsed to a single copy, but a 545 kbp region is absent and placed in a different contig (region B of ap_contig6). This scenario clearly shows the additional value added by optical maps and the importance of being mindful when presented with long contigs generated from relatively short DNA fragments.

To represent the haploid genome (in the style of a reference genome), we had concerns about the maps for Chromosomes 7, 6 and later 5, since all the ALLPATHS-LG contigs placed therein were duplicates of ones found in the first four maps. The maps for chr5–7 were considerably smaller in size than those preceeding. Furthermore, Mapsolver showed large map-to-map alignments between these two groups (chr1–4 to chr5–7), which strongly suggests that these regions are recombinations.

To test how well chr5–7 are supported by the sequencing data we generated two map-placed consensus sequences: one consisting of sequences for chr1–7 and another of sequences chr1–4. These were processed by the assembly evaluation pipeline, and the feature response curves (Fig. 4) clearly indicated that the assembly for chr1–4 is the best performing assembly, which it owes mainly to the reduction of low coverage regions when the Illumina reads are mapped. It also becomes obvious that chr1–4 is able to cover more of the genome than HGAP (the best performing assembly), while introducing fewer features: approximately 4900 in chr1–4 compared with 5800 in HGAP.

Fig. 4
figure 4

Total and low coverage feature response curves. The total feature response curves (a) only shown for HGAP, allpaths, chr1–7 and chr1–4. The decreased number of features when removing Chromosomes 7, 6 and 5 is mostly attributed to regions of low read coverage (b)

Validation using CEGMA

As an extra validation step we ran CEGMA [58], which maps the assembled sequences to a set of 458 highly conserved eukaryotic genes. For the 248 most extremely conserved genes, alignments to the queried assembly are classified as ‘complete’ or ‘partial’ depending on a fixed alignment length threshold. Of the total number of CEGMA hits, allpaths and HGAP performed equally with 246 hits of which one is a partial hit. While the results from CEGMA were not, in our case, essential to the evaluation of the assemblies (over 95 % completion for most assemblies, Additional file 1: Table S1), two observations are remarkable. First, FALCON and abyss, which we earlier established as ‘poor’, are reflected in these results by having a lower completion rate. Second, the final Dekkera assembly (chr1–4) received a total of 240 hits, of which three are partial hits (Fig. 5) retaining most of the core genes in an ordered and oriented manner. Further evidence of chr5–7 being artifacts of mis-assembly is the fact that excluding these did not reduce the total number of hits, only a partial loss of one hit. This can also be seen by the higher percentage of orthologous hits in chr5–7 (Additional file 1: Table S1).

Fig. 5
figure 5

Reported CEGMA gene hits. Barchart showing the number of hits to a set of 248 extremely conserved eukaryotic genes, as reported by CEGMA. Classified as either ‘complete’ or ‘partial’, depending on the alignment percentage

Genome completion using PacBio

We carefully investigated the proportion of optical maps that is assembled exclusively by HGAP. In other words, we wanted to check what we gain by combining Illumina and PacBio assemblies. HGAP contigs were able to add 487 kbp of new sequences, which ALLPATHS-LG was not able to reconstruct. Moreover, 363 kbp out of 532 kbp of ambiguous sequences (gaps and ambiguous base calls) could be replaced using the sequencing information from HGAP contigs. In total, the PacBio data allowed us to resolve slightly more than 5 % (Additional file 1: Table S3) of additional genomic content. We believe that, when automated, this presents an effective strategy for genome finishing.

Discussion

During a de novo project several decisions need to be taken, often based on little tangible information: which sequencing technology to use, which type of libraries to prepare, what sequencing depth to aim for, which assembler to employ, etc. A poor initial choice can lead to extremely poor results, and these choices are often guided by budget, available technology and/or in-house expertise. The multitude of different tools and approaches to de novo assembly can often lead to an inefficient trial-and-error approach to find acceptable results, prolonging the project and increasing the cost.

This study addressed the problem of the scarcity of methods for efficient scaffolding of genomic contigs into chromosomal units. Rapid development of sequencing technologies exceeded the establishment of pipelines for high-quality draft genome assembly and resulted in fast generation of low-quality genome drafts in public databases [59, 60]. Our study presents a solution to this problem. Using an efficient scaffolding approach guided by application of OpGen optical map placement allowed us to reconstruct the chromosomal makeup of a yeast species. Previously, presentation of a genome on the chromosome level was done only for a limited number of yeast species, and by using expensive and time consuming Sanger sequencing [34]. Other promising alternative scaffolding methods based on the conformation capture (3C) principle were shown to be efficient for several genomes, including that of the yeast Saccharomyces cerevisiae [61]. Our approach presents a simplified automated procedure of rapid ordering of PacBio and Illumina-derived contigs according to restriction maps from single microbial DNA molecules. The technique described in this paper can easily be extended to complex eukaryotic organisms. However, it must be taken into account that for larger eukaryotic genomes the steps involved in optical map scaffolding might be laborious and time consuming. Nevertheless, recent publications have shown how optical maps can greatly improve assembly results [29].

In this paper we have demonstrated a method requiring little effort to generate a high-quality draft assembly that can open up new opportunities for assembling complex genomes. In particular, we showed how combining several technologies and using a semi-automated pipeline can easily allow the production of an almost-finished yeast genome assembly. Thanks to their compact genomes and distinct physiological properties, yeasts are ideal model organisms to study evolution [62]. Evolution of a central core of about 4000 genes in the yeast genome has resulted in the origin of various yeast species [63]. Evolutionary events, such as gains and losses of genes were shown to be influenced by their location on a chromosome [64]. Thus, the representation of yeast genomes on the chromosomal scale will allow evolutionary events to be traced and a better understanding of the mechanistic basis behind the versatile diversity of yeast species. While our approach can easily be applied to a wider set of organisms, we assert that it has the potential to bring yeast comparative genomics up from the sequence level [65–68] to the level of chromosomal site analysis. This gives us a tool to extend our understanding of poorly investigated yeast genome structure and function.

The method presented in this study resulted in the determination of a haplotype number of chromosomes in this yeast strain. Analysis of the level of heterozygosity allows us to conclude that the examined genome is more than haploid. One limitation of the presented method is associated with its inability to identify exact ploidy. Additional biochemical methods may resolve ploidy characteristics, such as determining the amount of DNA per cell and its correlation to the genome size.

Conclusions

In this study we have demonstrated a novel way to combine three high-throughput technologies to produce a high quality assembly of the Dekkera bruxellensis genome. We employed an extensive number of assemblies using Illumina, PacBio, and a combination of the two technologies. We did this using a semi-automated pipeline that not only reduced the amount of time needed (in particular bioinformatic operator time) but also made our results easy to reproduce and validate. We used optical maps to resolve the genome on a chromosomal level and to error correct the inherent weaknesses of short-read assemblies, while using a long-read assembly to fill in uncovered regions. A set of utility scripts to produce a chromosome level assembly from optical map placement has been designed and is available together with the semi-automated de novo pipeline. Our de novo pipeline is currently used to process all de novo assembly projects currently sequenced at NGI-Stockholm. Hundreds of genomes per year are assembled, evaluated, and subsequently delivered to our users.

Availability and requirements

Project name: NouGAT

Project home page: https://github.com/SciLifeLab/NouGAT/

Operating system(s): Platform independent, Linux (64-bit) recommended

Programming language: Python 2.7

Other requirements: Anaconda (https://www.continuum.io/)

License: MIT

Any restrictions to use by non-academics: None

Availability of supporting data

The sequence data is available in the EBI ENA repository, under the study ERP012947. The data set supporting the results of this article is available in the GigaScience Database [69].

Abbreviations

ABySS:

Assembly By Short Sequences, assembly software

bp:

Base pair

CEGMA:

Core Eukaryotic Genes Mapping Approach, assembly evaluation software

chr:

Chromosome

FRC:

Feature response curves

HGAP:

Hierarchical Genome Assembly Process, assembly software

N50:

The length of the shortest contig greater than or equal to 50 % of the genome length

NGI:

National Genomics Infrastructure

NGS:

Next-generation sequencing

References

  1. Illumina. http://www.illumina.com/. Accessed 4 Nov 2015.

  2. Pacific Biosciences. http://www.pacificbiosciences.com/. Accessed 4 Nov 2015.

  3. Microbial Genetic Analysis - OpGen. http://opgen.com/. Accessed 4 Nov 2015.

  4. Ion TorrentTM. http://www.thermofisher.com/se/en/home/brands/ion-torrent.html. Accessed 4 Nov 2015.

  5. Oxford Nanopore Technologies. https://www.nanoporetech.com/. Accessed 4 Nov 2015.

  6. BioNano Genomics. http://www.bionanogenomics.com/. Accessed 4 Nov 2015.

  7. Nystedt B, Street NR, Wetterbom A, Zuccolo A, Lin Y-C, Scofield DG, et al. The Norway spruce genome sequence and conifer genome evolution. Nature. 2013;497:579–84.

    Article  CAS  PubMed  Google Scholar 

  8. Chin C-S, Alexander DH, Marks P, Klammer AA, Drake J, Heiner C, et al. Nonhybrid, finished microbial genome assemblies from long-read SMRT sequencing data. Nat Methods. 2013;10:563–9.

    Article  CAS  PubMed  Google Scholar 

  9. Chaisson MJP, Huddleston J, Dennis MY, Sudmant PH, Malig M, Hormozdiari F, et al. Resolving the complexity of the human genome using single-molecule sequencing. Nature. 2014;517:608–11.

    Article  PubMed  PubMed Central  Google Scholar 

  10. Guo X, Zheng S, Dang H, Pace RG, Stonebraker JR, Jones CD, et al. Genome reference and sequence variation in the large repetitive central exon of human MUC5AC. Am J Respir Cell Mol Biol. 2014;50:223–32.

    PubMed  PubMed Central  Google Scholar 

  11. Sharon D, Tilgner H, Grubert F, Snyder M. A single-molecule long-read survey of the human transcriptome. Nat Biotechnol. 2013;31:1009–14.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  12. Schwartz D, Li X, Hernandez L, Ramnarain S, Huff E, Wang Y. Ordered restriction maps of Saccharomyces cerevisiae chromosomes constructed by optical mapping. Science. 1993;262:110–4.

    Article  CAS  PubMed  Google Scholar 

  13. Anantharaman TS, Mishra B, Schwartz DC. Genomics via optical mapping. II: Ordered restriction maps. J Comput Biol. 1997;4:91–118.

    Article  CAS  PubMed  Google Scholar 

  14. Valouev A, Zhang Y, Schwartz DC, Waterman MS. Refinement of optical map assemblies. Bioinformatics. 2006;22:1217–24.

    Article  CAS  PubMed  Google Scholar 

  15. Valouev A, Li L, Liu Y-C, Schwartz DC, Yang Y, Zhang Y, et al. Alignment of optical maps. J Comput Biol. 2006;13:442–62.

    Article  CAS  PubMed  Google Scholar 

  16. Valouev A, Schwartz DC, Zhou S, Waterman MS. An algorithm for assembly of ordered restriction maps from single DNA molecules. Proc Natl Acad Sci U S A. 2006;103:15770–5.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  17. Jing J, Reed J, Huang J, Hu X, Clarke V, Edington J, et al. Automated high resolution optical mapping using arrayed, fluid-fixed DNA molecules. Proc Natl Acad Sci U S A. 1998;95:8046–51.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  18. Dimalanta ET, Lim A, Runnheim R, Lamers C, Churas C, Forrest DK, et al. A microfluidic system for large DNA molecule arrays. Anal Chem. 2004;76:5293–301.

    Article  CAS  PubMed  Google Scholar 

  19. Zhou S, Kile A, Bechner M, Place M, Kvikstad E, Deng W, et al. Single-Molecule Approach to Bacterial Genomic Comparisons via Optical Mapping. J Bacteriol. 2004;186:7773–82.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  20. Giongo A, Tyler HL, Zipperer UN, Triplett EW. Two genome sequences of the same bacterial strain, Gluconacetobacter diazotrophicus PAl 5, suggest a new standard in genome sequence submission. Stand Genomic Sci. 2010;2:309–17.

    Article  PubMed  PubMed Central  Google Scholar 

  21. Miller JM. Whole-genome mapping: A new paradigm in strain-typing technology. J Clin Microbiol. 2013;51:1066–70.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  22. Boers SA, Burggrave R, van Westreenen M, Goessens WHF, Hays JP. Whole-genome mapping for high-resolution genotyping of Pseudomonas aeruginosa. J Microbiol Methods. 2014;106C:19–22.

    Article  Google Scholar 

  23. Kidd JM, Cooper GM, Donahue WF, Hayden HS, Sampas N, Graves T, et al. Mapping and sequencing of structural variation from eight human genomes. Nature. 2008;453:56–64.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  24. Teague B, Waterman MS, Goldstein S, Potamousis K, Zhou S, Reslewic S, et al. High-resolution human genome structure by single-molecule analysis. Proc Natl Acad Sci U S A. 2010;107:10848–53.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  25. Gupta A, Place M, Goldstein S, Sarkar D, Zhou S, Potamousis K, et al. Single-molecule analysis reveals widespread structural variation in multiple myeloma. Proc Natl Acad Sci U S A. 2015;112:7689–94.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  26. Raeside C, Gaffé J, Deatherage DE, Tenaillon O, Briska AM, Ptashkin RN, et al. Large chromosomal rearrangements during a long-term evolution experiment with Escherichia coli. MBio. 2014;5:e01377–14.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  27. Sabirova JS, Xavier BB, Ieven M, Goossens H, Malhotra-Kumar S. Whole genome mapping as a fast-track tool to assess genomic stability of sequenced Staphylococcus aureus strains. BMC Res Notes. 2014;7:704.

    Article  PubMed  PubMed Central  Google Scholar 

  28. Coleman JJ, Rounsley SD, Rodriguez-Carres M, Kuo A, Wasmann CC, Grimwood J, et al. The genome of Nectria haematococca: contribution of supernumerary chromosomes to gene expansion. PLoS Genet. 2009;5:e1000618.

    Article  PubMed  PubMed Central  Google Scholar 

  29. Dong Y, Xie M, Jiang Y, Xiao N, Du X, Zhang W, et al. Sequencing and automated whole-genome optical mapping of the genome of a domestic goat (Capra hircus). Nat Biotechnol. 2013;31:135–41.

    Article  CAS  PubMed  Google Scholar 

  30. Zhou S, Wei F, Nguyen J, Bechner M, Potamousis K, Goldstein S, et al. A single molecule scaffold for the maize genome. PLoS Genet. 2009;5:e1000711.

    Article  PubMed  PubMed Central  Google Scholar 

  31. Church DM, Goodstadt L, Hillier LW, Zody MC, Goldstein S, She X, et al. Lineage-specific biology revealed by a finished genome assembly of the mouse. PLoS Biol. 2009;7:e1000112.

    Article  PubMed  PubMed Central  Google Scholar 

  32. Dujon B. Yeast evolutionary genomics. Nat Rev Genet. 2010;11:512–24.

    Article  CAS  PubMed  Google Scholar 

  33. Ford CB, Funt JM, Abbey D, Issi L, Guiducci C, Martinez DA, et al. The evolution of drug resistance in clinical isolates of Candida albicans. Elife. 2014;4:e00662.

    Google Scholar 

  34. Goffeau A, Barrell BG, Bussey H, Davis RW, Dujon B, Feldmann H, et al. Life with 6000 genes. Science. 1996;274:546. 563-7.

    Article  CAS  PubMed  Google Scholar 

  35. Schacherer J, Ruderfer DM, Gresham D, Dolinski K, Botstein D, Kruglyak L. Genome-wide analysis of nucleotide-level variation in commonly used Saccharomyces cerevisiae strains. PLoS One. 2007;2:e322.

    Article  PubMed  PubMed Central  Google Scholar 

  36. Liti G, Carter DM, Moses AM, Warringer J, Parts L, James SA, et al. Population genomics of domestic and wild yeasts. Nature. 2009;458:337–41.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  37. Schacherer J, Shapiro JA, Ruderfer DM, Kruglyak L. Comprehensive polymorphism survey elucidates population structure of Saccharomyces cerevisiae. Nature. 2009;458:342–5.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  38. Magee BB, Magee PT. Electrophoretic karyotypes and chromosome numbers in Candida species. J Gen Microbiol. 1987;133:425–30.

    CAS  PubMed  Google Scholar 

  39. Passoth V, Hansen M, Klinner U, Emeis CC. The electrophoretic banding pattern of the chromosomes of Pichia stipitis and Candida shehatae. Curr Genet. 1992;22:429–31.

    Article  CAS  PubMed  Google Scholar 

  40. Hellborg L, Piškur J. Complex nature of the genome in a wine spoilage yeast, Dekkera bruxellensis. Eukaryot Cell. 2009;8:1739–49.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  41. Vigentini I, De Lorenzis G, Picozzi C, Imazio S, Merico A, Galafassi S, et al. Intraspecific variations of Dekkera/Brettanomyces bruxellensis genome studied by capillary electrophoresis separation of the intron splice site profiles. Int J Food Microbiol. 2012;157:6–15.

    Article  CAS  PubMed  Google Scholar 

  42. NouGAT. https://github.com/SciLifeLab/NouGAT/. Accessed 4 Nov 2015.

  43. Earl DA, Bradnam K, St John J, Darling A, Lin D, Faas J, et al. Assemblathon 1: A competitive assessment of de novo short read assembly methods. Genome Res. 2011;21(12):2224–41. doi:10.1101/gr.126599.111.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  44. Bradnam KR, Fass JN, Alexandrov A, Baranay P, Bechner M, Birol I, et al. Assemblathon 2: evaluating de novo methods of genome assembly in three vertebrate species. Gigascience. 2013;2:10.

    Article  PubMed  PubMed Central  Google Scholar 

  45. Salzberg SL, Phillippy AM, Zimin A, Puiu D, Magoc T, Koren S, et al. GAGE: A critical evaluation of genome assemblies and assembly algorithms. Genome Res. 2012;22:557–67.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  46. Bolger AM, Lohse M, Usadel B. Trimmomatic: a flexible trimmer for Illumina sequence data. Bioinformatics. 2014;30:2114–20.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  47. Simpson JT, Wong K, Jackman SD, Schein JE, Jones SJM, Birol I. ABySS: a parallel assembler for short read sequence data. Genome Res. 2009;19:1117–23.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  48. FastQC A Quality Control tool for High Throughput Sequence Data. http://www.bioinformatics.babraham.ac.uk/projects/fastqc/. Accessed 4 Nov 2015.

  49. Vezzi F, Narzisi G, Mishra B. Feature-by-feature--evaluating de novo sequence assembly. PLoS One. 2012;7:e31002.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  50. Clark SC, Egan R, Frazier PI, Wang Z. ALE: a generic assembly likelihood evaluation framework for assessing the accuracy of genome and metagenome assemblies. Bioinformatics. 2013;29:435–43.

    Article  CAS  PubMed  Google Scholar 

  51. Rahman A, Pachter L. CGAL: computing genome assembly likelihoods. Genome Biol. 2013;14:R8.

    Article  PubMed  PubMed Central  Google Scholar 

  52. Gnerre S, Maccallum I, Przybylski D, Ribeiro FJ, Burton JN, Walker BJ, et al. High-quality draft assemblies of mammalian genomes from massively parallel sequence data. Proc Natl Acad Sci U S A. 2011;108:1513–8.

    Article  CAS  PubMed  Google Scholar 

  53. Luo R, Liu B, Xie Y, Li Z, Huang W, Yuan J, et al. SOAPdenovo2: an empirically improved memory-efficient short-read de novo assembler. Gigascience. 2012;1:18.

    Article  PubMed  PubMed Central  Google Scholar 

  54. FALCON: Experimental PacBio Diploid Assembler. https://github.com/PacificBiosciences/FALCON. Accessed 4 Nov 2015.

  55. Bashir A, Klammer AA, Robins WP, Chin C-S, Webster D, Paxinos E, et al. A hybrid approach for the automated finishing of bacterial genomes. Nat Biotechnol. 2012;30:701–7.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  56. Miller JR, Delcher AL, Koren S, Venter E, Walenz BP, Brownley A, et al. Aggressive assembly of pyrosequencing reads with mates. Bioinformatics. 2008;24:2818–24.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  57. Vicedomini R, Vezzi F, Scalabrin S, Arvestad L, Policriti A. GAM-NGS: genomic assemblies merger for next generation sequencing. BMC Bioinformatics. 2013;14 Suppl 7:S6.

    Article  PubMed  PubMed Central  Google Scholar 

  58. Parra G, Bradnam K, Korf I. CEGMA: a pipeline to accurately annotate core genes in eukaryotic genomes. Bioinformatics. 2007;23:1061–7.

    Article  CAS  PubMed  Google Scholar 

  59. Field D, Garrity G, Gray T, Morrison N, Selengut J, Sterk P, et al. The minimum information about a genome sequence (MIGS) specification. Nat Biotechnol. 2008;26:541–7.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  60. Chain PSG, Grafham DV, Fulton RS, Fitzgerald MG, Hostetler J, Muzny D, et al. Genomics. Genome project standards in a new era of sequencing. Science. 2009;326:236–7.

    Article  CAS  PubMed  Google Scholar 

  61. Marie-Nelly H, Marbouty M, Cournac A, Flot J-F, Liti G, Parodi DP, et al. High-quality genome (re)assembly using chromosomal contact data. Nat Commun. 2014;5:5695.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  62. Dujon B, Sherman D, Fischer G, Durrens P, Casaregola S, Lafontaine I, et al. Genome evolution in yeasts. Nature. 2004;430:35–44.

    Article  PubMed  Google Scholar 

  63. Scannell DR, Butler G, Wolfe KH. Yeast genome evolution--the origin of the species. Yeast. 2007;24:929–42.

    Article  CAS  PubMed  Google Scholar 

  64. Bergström A, Simpson JT, Salinas F, Barré B, Parts L, Zia A, et al. A high-definition view of functional genetic variation from natural yeast genomes. Mol Biol Evol. 2014;31:872–88.

    Article  PubMed  PubMed Central  Google Scholar 

  65. Jackson AP, Gamble JA, Yeomans T, Moran GP, Saunders D, Harris D, et al. Comparative genomics of the fungal pathogens Candida dubliniensis and Candida albicans. Genome Res. 2009;19:2231–44.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  66. Souciet J-L, Dujon B, Gaillardin C, Johnston M, Baret PV, Cliften P, et al. Comparative genomics of protoploid Saccharomycetaceae. Genome Res. 2009;19:1696–709.

    Article  PubMed  PubMed Central  Google Scholar 

  67. Rhind N, Chen Z, Yassour M, Thompson DA, Haas BJ, Habib N, et al. Comparative functional genomics of the fission yeasts. Science. 2011;332:930–6.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  68. Wendland J, Walther A. Genome evolution in the eremothecium clade of the Saccharomyces complex revealed by comparative genomics. G3 (Bethesda). 2011;1:539–48.

    Article  CAS  Google Scholar 

  69. Olsen R, Bunikis I, Tiukova I, Holmberg K, Lotstedt B, Pettersson OV, et al. Supporting data and materials for the de novo assembly of Dekkera bruxellensis CBS11270 using multiple technologies. GigaScience Database. 2015. doi:10.5524/100179.

Download references

Acknowledgements

We thank S. Lundin for help with the manuscript in the early stages. The authors would like to acknowledge the support of National Genomic Infrastructure Stockholm node and Uppsala node (Uppsala Genome Center) together with UPPMAX for providing assistance with massive parallel sequencing and computational infrastructure. Work performed at Uppsala node (Uppsala Genome Center) was funded by RFI/VR ‘SNISS’ Swedish National Infrastructure for Large Scale Sequencing and the Science for Life Laboratory, Uppsala.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Remi-Andre Olsen.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors’ contributions

RAO carried out the bioinformatic analyses and drafted the manuscriptIB performed PacBio sequencing and assembly. IT cultivated the yeast, performed DNA extraction, and was involved in the bioinformatic analyses. KH performed the optical mapping experiments. BL prepared the mate-pair libraries. FV was involved in the bioinformatic analyses, drafting the manuscript and planning the project. VP was involved in planning the project and drafting the manuscript. MK and OVP was involved in planning the project. FV and RAO developed NouGAT. All authors have read and approved the final manuscript.

Remi-Andre Olsen and Ignas Bunikis contributed equally to this work.

Additional file

Additional file 1:

Additional figures and tables, including method descriptions. (PDF 721 kb)

Rights and permissions

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

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Olsen, RA., Bunikis, I., Tiukova, I. et al. De novo assembly of Dekkera bruxellensis: a multi technology approach using short and long-read sequencing and optical mapping. GigaSci 4, 56 (2015). https://doi.org/10.1186/s13742-015-0094-1

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s13742-015-0094-1

Keywords