Skip to main content

ORIGINAL RESEARCH article

Front. Genet., 25 June 2014
Sec. Computational Genomics

A consensus approach to vertebrate de novo transcriptome assembly from RNA-seq data: assembly of the duck (Anas platyrhynchos) transcriptome

  • 1Advanced Data Analysis Centre, University of Nottingham, Leicestershire, UK
  • 2School of Veterinary Medicine and Science, University of Nottingham, Leicestershire, UK

For vertebrate organisms where a reference genome is not available, de novo transcriptome assembly enables a cost effective insight into the identification of tissue specific or differentially expressed genes and variation of the coding part of the genome. However, since there are a number of different tools and parameters that can be used to reconstruct transcripts, it is difficult to determine an optimal method. Here we suggest a pipeline based on (1) assessing the performance of three different assembly tools (2) using both single and multiple k-mer (MK) approaches (3) examining the influence of the number of reads used in the assembly (4) merging assemblies from different tools. We use an example dataset from the vertebrate Anas platyrhynchos domestica (Pekin duck). We find that taking a subset of data enables a robust assembly to be produced by multiple methods without the need for very high memory capacity. The use of reads mapped back to transcripts (RMBT) and CEGMA (Core Eukaryotic Genes Mapping Approach) provides useful metrics to determine the completeness of assembly obtained. For this dataset the use of MK in the assembly generated a more complete assembly as measured by greater number of RMBT and CEGMA score. Merged single k-mer assemblies are generally smaller but consist of longer transcripts, suggesting an assembly consisting of fewer fragmented transcripts. We suggest that the use of a subset of reads during assembly allows the relatively rapid investigation of assembly characteristics and can guide the user to the most appropriate transcriptome for particular downstream use. Transcriptomes generated by the compared assembly methods and the final merged assembly are freely available for download at http://dx.doi.org/10.6084/m9.figshare.1032613.

Introduction

In recent years, RNA sequencing (RNA-seq) has been used to study the transcriptomic profile of many organisms. The most often used approach is to align the obtained short sequence reads to a reference genome sequence. However, when a reference is not available de novo transcriptome assembly can be used instead. Software pipelines to conduct this task have been developed, for example; ABySS (Simpson et al., 2009), CLC (www.clcbio.com), MIRA (Chevreux et al., 2004), Newbler (Roche), SOAPdenovo (Li et al., 2010), Trinity (Grabherr et al., 2011), and Velvet-Oases (hereafter referred to as Oases) (Schulz et al., 2012).

In de novo assembly transcripts are constructed by attempting to overlap reads into a contiguous sequence (“contig”), each representing a unique transcript. Unlike genome assembly where approximately even coverage (number of reads aligned at a single position) is expected, transcriptome assembly is complicated by variable coverage caused by differences in gene expression. An important parameter used in the assembly is the length of the overlapping piece of reads to join them together in an assembly, known as k-mer length. Robertson et al. (2010) have shown that lower k-mer values tend to represent lowly expressed transcripts more effectively whilst transcripts with higher coverage are better assembled with higher k-mer values. A multiple k-mer (MK) approach can therefore be adopted to capture transcripts at a wider range of expression levels compared to using a single k-mer (SK) assembly (Robertson et al., 2010; Surget-Groba and Montoya-Burgos, 2010; Zhao et al., 2011). In the MK strategy, assemblies generated from different single k-mer lengths are merged to produce a robust transcriptome of sequences expressed at different levels. The second stage of the Oases pipeline (Oases-M) was developed for this purpose (Schulz et al., 2012) as was the de novo transcriptome assembler Trans-ABySS (Robertson et al., 2010).

Since there are a number of different tools and parameters that can be used to reconstruct transcripts, it can be difficult to determine a single robust method. A few studies have assessed different de novo approaches from varying sequencing platforms and transcriptome data sets. For example, parasitic nematode 454 data (Kumar and Blaxter, 2010); simulated human 454 sequences (Mundry et al., 2012); plant paired-end Illumina data (Barrero et al., 2011) and paired-end Illumina fly, yeast and plant data sets (Zhao et al., 2011). Two of these papers focused on comparing different tools (Kumar and Blaxter, 2010; Mundry et al., 2012). Barrero et al. (2011) went on to optimize the k-mer value after selecting Oases from six preliminary assemblers. Zhao et al. (2011) assessed different assemblers and identified the MK approach as a significant improvement to the SK strategy. Alongside the comparison of programs, Kumar and Blaxter (2010) also merged assemblies from different assemblers and found that these generated a more credible final transcriptome. Here, we develop a pipeline to incorporate sequences from multiple assemblers and parameters to generate a robust consensus transcriptome.

Sequencing depth is also an important consideration for transcriptome assembly. Recently Francis et al. (2013) suggested that representative de novo assemblies can be generated from a random sub-sample of reads to achieve transcriptomes with a good balance of coverage and noise. Therefore, in our pipeline, alongside comparison of tools and parameters, we also examine the influence of the number of reads on transcriptome assembly.

Materials and Methods

Library Preparation and Sequencing

Total RNA from Anas platyrhynchos domestica embryo fibroblasts grown in tissue culture was provided to Source Bioscience (Nottingham, UK) who carried out the library preparation and sequencing. The libraries were prepared using the Illumina TruSeq RNA Sample Preparation kit. The mRNA in the total RNA was purified using poly-T oligo-attached magnetic beads to pull down the poly-A mRNA. After purification, the mRNA was fragmented and copied into first strand cDNA using reverse transcriptase and random primers. This was followed by second strand cDNA synthesis using DNA Polymerase I and RNase H. The newly formed cDNA goes through a process of end repair, the addition of a single 'A' base and the ligation of the adapters. The samples that contain the adapters are selectively enriched for using PCR to create the final library. The libraries were validated using the Agilent BioAnalyser 2100. The libraries were clustered on to a HiSeq v3 flow cell using the Illumina cBot and sequenced on the Illumina HiSeq 2000 using a 100 base pair (bp) sequencing run generating 412 million paired-end reads. Sequence reads used in this assembly are available at European Nucleotide Archive under the study identifier PRJEB6385.

Quality Filter Reads

In comparison to traditional Sanger sequencing, high-throughput sequencing is more error-prone and therefore it is important to pre-process the reads by performing quality trimming (MacManes, 2014). It is also possible for adapter fragments to remain in the read sequences and these should be removed before any downstream analysis is carried out (Lindgreen, 2012). There are many programs available for these tasks such as AdapterRemoval (Lindgreen, 2012), Cutadapt (Martin, 2011), and Trimmomatic (Lohse et al., 2012). For this study we used CLC Genomics Workbench (Version 6, www.clcbio.com) to apply quality and adapter trimming to the read sequences using the following settings: (1) Removal of low quality sequence, limit = 0.05 (2) maximal 2 ambiguous nucleotides allowed (3) minimum length 20 nucleotides. In CLC each quality score is converted to an error probability where low values represent high quality bases. For each base the error probability is subtracted from the limit (0.05 here). The cumulative total of this value (limit—error) is calculated for each base and it is set at zero if it becomes negative. The retained part of the read will start at the first positive value and end at the highest value of the cumulative total. Duplicate reads were also removed using CLC Genomics Workbench and the reads were kept if they were greater than 50 bp. Table 1 shows the effect of trimming, duplicate read removal and filtering on the number of reads.

TABLE 1
www.frontiersin.org

Table 1. The effect of trimming, duplicate read removal, and filtering on the number of reads.

De Novo Assembly Using all Reads (Single k-mers)

Velvet (version 1.2.08) (Zerbino and Birney, 2008) followed by Oases (version 0.2.08) (Schulz et al., 2012) was used to de novo assemble all 277 million quality filtered reads (Table 1) using odd numbers between 21 and 79 inclusively as k-mer values. The parameters used with Velvet were “-short, -shortPaired” and Oases “-ins_length 305, -min_trans_lgth 200” to set the minimum sequence length in the output files to 200 bp. Unfortunately the Oases assemblies for k = 21–31 failed likely due to a lack of memory even when running on an Ubuntu server with 24 cores (Xeon X5690, 3.46 GHz) and 192 G (1333 MHz ECC) of memory highlighting the difficulty of using relatively large data sets with all suggested options of Oases.

The CLC de novo assembly tool was run on all of the reads using k = 25 (automatic word size), k = 34 and k = 62 all with the following parameters: (1) Mapping mode = Create simple contig sequences (2) Automatic bubble size = Yes (3) Minimum contig length = 200 (4) Perform scaffolding = Yes (5) Auto-detect paired distances = Yes. Fewer k-mer values were used because CLC could not be set to generate assemblies for many k-mers in batch mode. The Oases and CLC assemblies of all 277 million reads were performed on an Ubuntu server with 24 cores (Xeon X5690, 3.46 GHz) and 192 G (1333 MHz ECC) of memory.

De Novo Assembly Using a Sub-Sample of Reads (Single k-mers)

Reads were subsampled using a perl script utilizing the rand function to choose “random” reads without replacement (script available at https://github.com/ADAC-UoN/subset.fastq). Velvet (version 1.2.09) followed by Oases (version 0.2.08) and ABySS (version 1.3.5) (Simpson et al., 2009) were run on a sub-sample of 30 million post-quality filtered paired reads using odd values between k = 21 and 79 inclusively. The “-shortPaired” parameter was used with Velvet and for Oases “-ins_length 305” and “-min_trans_lgth 200.” Default ABySS parameters were used with number of threads set as 32. The Velvet-Oases and ABySS assemblies of the sub-sample were performed on a CentOS server with 32 cores (AMD Opteron 6386SE, 2.8 GHz) and 192 G (1600 MHz DDR3 SDRAM) of memory.

The CLC de novo assembly tool was also run on the random sub-sample for every other odd k-mer value from k = 21 up to k = 63 (CLC maximum k = 64). The same parameters were used as the assemblies of all the reads and all CLC assemblies were conducted on an Ubuntu server with 24 cores (Xeon X5690, 3.46 GHz) and 192 G (1333 MHz ECC) of memory.

De Novo Assembly (Multiple k-mers)

The results from all SK assemblies were merged for each tool using the supplied Oases python script “oases_pipeline.py” (Oases-M). The default value of k = 27 was used for the merge as recommended in the Oases manual. For SK assemblies using all of the reads, Oases MK was run using odd values between k = 33 and 79 inclusively (k = 21–31 failed for SK) and CLC MK was run on k = 25, k = 34 and k = 62. These MK assemblies were executed on an Ubuntu server with 24 cores (Xeon X5690, 3.46 GHz) and 192 G (1333 MHz ECC) of memory.

For the assemblies of the sub-sample, Oases and ABySS MK were run using odd values between k = 21 and 79 inclusively whereas CLC MK was run on every other odd k-mer value in the same range. The MK assemblies of the SK sub-sample assemblies were completed on a CentOS server with 32 cores (AMD Opteron 6386SE, 2.8 GHz) and 192 G (1600 MHz DDR3 SDRAM) of memory.

Remove Redundancy and Short Transcript Sequences

In each assembly, shorter transcripts that shared more than 99% identity with other transcripts (within a single assembly) were removed using the cd-hit-est program (Version 4.6) (Li and Godzik, 2006). Non-redundant sequences that were greater than 200 bp were kept.

Reads Mapped Back to Transcripts (RMBT)

To assess the validity of each of the assemblies, the reads unselected in the random sub-sampling process were aligned back to the transcript sequences using Bowtie2 (Version 2.1.0) (Langmead and Salzberg, 2012) end-to-end mode. For the assemblies generated using all of the reads, the entire set of reads was mapped back using Bowtie2 end-to-end.

Merging Assemblies for Improved Reliability

For comparison, one SK assembly was selected for each tool by maximizing the N50 value whilst keeping the total assembly length as long as possible (Zerbino, 2010). CAP3 (Huang and Madan, 1999) was used in an attempt to merge the three selected SK assemblies produced from the sub-sample of 30 million pairs of reads (Oases k = 23, ABySS k = 35 and CLC k = 25) plus the three MK sub-sample assemblies (Table 2B). Secondly, a consensus assembly was generated with CAP3 from just the three selected SK sub-sample assemblies (Oases k = 23, ABySS k = 35 and CLC k = 25). A final consensus assembly was created with the three selected SK sub-sample assemblies plus the assemblies produced from three largest k-mers (k = 79 for Oases and ABySS and k = 61 for CLC) using CAP3. The default CAP3 (VersionDate: 12/21/07) settings were used for all of the assemblies as described previously (Kumar and Blaxter, 2010). Supplemental Figure 1 shows a workflow of assembly procedure.

TABLE 2
www.frontiersin.org

Table 2. Assembly statistics for all reads and sub-sample of reads.

CEGMA (Core Eukaryotic Genes Mapping Approach)

As a proxy to assess the completeness of the transcriptomes assembled, the Core Eukaryotic Genes Mapping Approach (CEGMA) tool was used (Parra et al., 2007). CEGMA facilitates alignment of hidden Markov models (HMMs) of 458 core genes predicted to be ubiquitous in eukaryote species to report if a transcriptome contains predicted transcripts encoding these essential genes. The resulting completeness report details the percentage of the core genes that are either complete or partial (fragmented or truncated alignment) in the dataset.

Results

Generation of Different De Novo Transcript Assemblies

De novo transcriptomes were first generated using all of the 277 million quality filtered reads then on a random sub-sample of 30 million paired reads to try to establish a good balance of coverage and noise (Francis et al., 2013). The sub-sample was randomly selected from the quality filtered reads (after trimming, duplicate removal, and removal of reads less than 50 bp). A range of tools and k-mer values were tested for the de novo assemblies. Zerbino (2010) suggested using k-mer lengths between 21 bp and the average read length (here 89 bp) minus 10 bp. Initially Velvet-Oases and CLC Genomics Workbench were used for the assemblies of all reads. ABySS was also applied for the assembly of the sub-sample because it is less resource intensive whilst maintaining the quality of the assembly (Zhao et al., 2011). Both single and MK methods were used. The MK approach allowed the combining of lower and higher values of k which produce more sensitive and specific assemblies respectively (Schulz et al., 2012).

Comparison of Assemblies

The following metrics were assessed for each assembly: (1) number of contigs (transcripts) assembled; (2) total number of bps in the assembly; (3) Mean transcript length; (4) N50 value; (5) reads that could be mapped back to assembled transcripts (RMBT) (6) number of long transcripts (>1 kb) and (7) complete and partial core genes identified by CEGMA. For comparison, one SK assembly was selected for each tool by maximizing the N50 value whilst keeping the total assembly length as long as possible (Zerbino, 2010). The selected SK values for assemblies of all reads were Oases k = 39 and CLC k = 25 and for the sub-sample: Oases k = 23, CLC k = 25 and ABySS k = 35. For example, Figure 1 shows the N50 values and assembly length for all ABySS k-mer assemblies (30 M reads). With increased k-mer the N50 increases to k = 55 at which point the N50 deteriorates, likely due to the k-mer exceeding half the length of the sequence reads (average length 89 bp). The number of RMBT and CEGMA complete gene percentages are higher in the MK methods compared to SK. In particular the ABySS SK method has lower CEGMA and RMBT scores. Using these metrics the CLC MK assembly scored well with highest RMBT (95.06%) and CEGMA (94.8% complete 99.2% partial assembly of core genes). The selected SK and MK assembly statistics for all reads and the sub-sample of reads are shown in Table 2. The statistics are based on non-redundant sequences greater than 200 bp (Materials and Methods).

FIGURE 1
www.frontiersin.org

Figure 1. N50 values and assembly length in base pairs (bp) for every ABySS k-mer assembly generated from a random sub-sample of 30 million post-quality filtered reads.

Merging Assemblies to Provide a Consensus Transcriptome

In an attempt to produce a consensus assembly, CAP3 was used to merge the six assemblies (3 × SK and 3 × MK), produced from the sub-sample of 30 million pairs of reads (for read details see Table 2B). CAP3 failed to merge all six assemblies because it ran out of memory however the three selected SK assemblies (one from each tool) could be merged. Only robust contigs i.e., those that that were present in all original assemblies were retained (Kumar and Blaxter, 2010).

By using only the SK assemblies the advantage of the MK assemblies was lost by missing both sensitive and specific assemblies. The three SK assemblies that were merged had quite low k-mer values (Oases k = 23, ABySS k = 35 and CLC k = 25). Therefore, the largest k-mers that the assemblies were run on (k = 79 for Oases and ABySS and k = 61 for CLC) were also used in the merge to supplement the k-mers already selected. These six SK assemblies (two single k-mer assemblies from each tool) were merged with CAP3 and robust contigs for this data set were defined as those assembled by three different tools but not necessarily from all six assemblies. The merged assembly statistics (3 SK and 6 SK) are shown in Table 3 and are based on non-redundant sequences greater than 200 bp (Materials and Methods). Transcriptomes generated by the compared assembly methods and the final robust merged assembly are freely available for download at http://dx.doi.org/10.6084/m9.figshare.1032613.

TABLE 3
www.frontiersin.org

Table 3. Merged assembly statistics.

Of the final merged assemblies, the one that combined the six SK assemblies had a higher percentage of reads mapping back to transcripts (RMBT) compared to the 3 SK assembly. The CEGMA analysis revealed that the 81.9% of core genes are complete in the 6 SK assembly and 89.1% of genes are present in a partial form. The mean transcript length, N50 values and number of long transcripts (>1 kb) were also higher for the six-merged assemblies compared to the three-merged (Table 3). The RMBT percentages were generally lower for the merged assemblies compared to the individual SK and MK assemblies (Tables 2, 3). However, this was to be expected as only robust contigs were considered for the merged assembly. The N50 values increased for the merged assemblies (maximum 4155, Table 3) compared to the individual SK and MK assemblies (maximum 3659, Table 2).

Discussion

The SK assembly metrics from the different tools varied, for example CLC was quicker but generated contigs with a lower N50 value. Among the SK assemblies, Oases produced the ones with the highest number of bps, mean transcript lengths, N50 values, RMBT percentages, and long transcripts (Table 2). This tool also took less time to assemble the transcripts compared to ABySS. It is difficult to compare the MK assemblies from the three tools directly because different numbers of k-mer assemblies were generated. For instance, some of the Oases assemblies (k = 21–31) failed from insufficient memory when all reads were used. However, in comparison to SK, the MK assemblies were longer and had a higher percentage of reads mapping back to transcripts (RMBT) which is an important measure for evaluating the assembly (Zhao et al., 2011) and a greater number of core genes identified by CEGMA, suggesting a more complete transcriptome. Together, this suggests the MK assemblies are likely to represent a wider range of transcripts.

The commonly used metrics to determine assembly quality (N50 values and RMBT percentages) show the variability between assemblies. Importantly the sub-sample of reads requires much less time was and computational power making this method more tractable for those with limited memory resources. The use of a sub-sample of reads can also provide further validation by mapping the unselected reads (those not used in the assembly) to the generated assembly. Using this approach, the RMBT percentages were lower for the merged assemblies but only robust contigs were considered so this was expected. The N50 values increased greatly for the merged assemblies compared to the individual SK and MK assemblies. Of the final merged assemblies, the one that combined the six SK assemblies had a higher RMBT percentage, larger mean transcript length, larger N50 value and more long transcripts (>1 kb) compared to the three-merged. We suggest that the lower RMBT values seen are not of concern when the aim is to generate a robust assembly that contains high quality transcripts. This value may be more relevant if the aim is to generate the most comprehensive transcriptome set. This is also true for the CEGMA analysis, where the final “robust” transcriptome (6 SK), which did not have the highest percentage of complete expected genes (81.85% compared to a maximum of 94.76% from the CLC MK assembly), however we believe the 6 SK assembly represents a more cautious assembly by reducing potential false positive transcripts. The 6 SK assembly also has a much higher proportion of longer transcripts (>1 Kb) 18,104/24,834 (72.9%). In contrast the CLC MK assembly has only 35.6% longer transcripts (51,516/144,789 see Table 2) suggesting that shorter, potentially fragmented transcripts dominate the assembly. The need to create a de novo assembly suggests that the “truth” is not known and hence all assemblies will necessitate a compromise to balance many different parameters. The downstream use of the assembly should be considered when selecting methods for assembly. All the assemblies generated by this study are available at http://dx.doi.org/10.6084/m9.figshare.1032613 and may be utilized by different groups for different purposes. For example if the most comprehensive transcriptome is required possibly the CLC MK assembly (highest CEGMA score, highest RMBT score) would be valid.

The results here suggest that a robust de novo transcriptome can be generated, with limited computational resources using (1) a random sub-sample of the reads; (2) three different assembly tools; (3) merging the assemblies of two SK assemblies from each tool. However, we stress that the user should use assembly metrics such as RMBT and CEGMA scores or similar to understand and balance the breadth (number of transcripts discovered) and robustness (completeness of the transcripts identified) for their particular needs. In our approach, reads were sub-sampled to establish a good balance of coverage and noise (Francis et al., 2013). A high proportion of reads unselected in the sub-sampling process map to transcripts generated from the sub-sample. This suggests that sub-sampling does not drastically impact on the complexity of the transcriptome generated even though more reads were used than suggested by Francis et al. (2013). For the third part of the pipeline we selected (for each tool) one SK assembly by maximizing the N50 value whilst keeping the total assembly length as long as possible (Zerbino, 2010) and secondly the largest k-mer that the assemblies were run on. This was to try to take advantage of the MK approach by combining more sensitive and specific assemblies (Schulz et al., 2012) without running out of memory when merging the transcriptomes. The three stage approach proposed enables the efficient use of different tools and parameters to reconstruct a robust consensus of vertebrate transcripts. The second stage resulted in a more comprehensive assembly, whereas the last stage produced an assembly with longer transcripts that was likely to have fewer false positives, but was also less comprehensive.

Conflict of Interest Statement

The authors declare that the research was conducted in the absence of any commercial or financial relationships that could be construed as a potential conflict of interest.

Acknowledgments

Funding was provided by the School of Veterinary Medicine and Science, University of Nottingham. We would like to thank the three reviewers for careful and constructive comments, which have aided clarity of the manuscript.

Supplementary Material

The Supplementary Material for this article can be found online at: http://www.frontiersin.org/journal/10.3389/fgene.2014.00190/abstract

Supplemental Figure 1 | Cartoon schematic of experimental workflow.

References

Barrero, R. A., Chapman, B., Yang, Y., Moolhuijzen, P., Keeble-Gagnère, G., Zhang, N., et al. (2011). De novo assembly of Euphorbia fischeriana root transcriptome identifies prostratin pathway related genes. BMC Genomics 12:600. doi: 10.1186/1471-2164-12-600

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Chevreux, B., Pfisterer, T., Drescher, B., Driesel, A. J., Müller, W. E., Wetter, T., et al. (2004). Using the miraEST assembler for reliable and automated mRNA transcript assembly and SNP detection in sequenced ESTs. Genome Res. 14, 1147–1159. doi: 10.1101/gr.1917404

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Francis, W. R., Christianson, L. M., Kiko, R., Powers, M. L., Shaner, N. C., and Haddock, S. H. (2013). A comparison across non-model animals suggests an optimal sequencing depth for de novo transcriptome assembly. BMC Genomics 14:167. doi: 10.1186/1471-2164-14-167

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Grabherr, M. G., Haas, B. J., Yassour, M., Levin, J. Z., Thompson, D. A., Amit, I., et al. (2011). Full-length transcriptome assembly from RNA-seq data without a reference genome. Nat. Biotechnol. 29, 644–652. doi: 10.1038/nbt.1883

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Huang, X., and Madan, A. (1999). CAP3: a DNA sequence assembly program. Genome Res. 9, 868–877. doi: 10.1101/gr.9.9.868

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Kumar, S., and Blaxter, M. L. (2010). Comparing de novo assemblers for 454 transcriptome data. BMC Genomics 11:571. doi: 10.1186/1471-2164-11-571

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Langmead, B., and Salzberg, S. L. (2012). Fast gapped-read alignment with Bowtie 2. Nat. Methods 9, 357–359. doi: 10.1038/nmeth.1923

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Li, R., Zhu, H., Ruan, J., Qian, W., Fang, X., Shi, Z., et al. (2010). De novo assembly of human genomes with massively parallel short read sequencing. Genome Res. 20, 265–272. doi: 10.1101/gr.097261.109

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Li, W., and Godzik, A. (2006). Cd-hit: a fast program for clustering and comparing large sets of protein or nucleotide sequences. Bioinformatics 22, 1658–1659. doi: 10.1093/bioinformatics/btl158

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Lindgreen, S. (2012). AdapterRemoval: easy cleaning of next-generation sequencing reads. BMC Res. Notes 5:337. doi: 10.1186/1756-0500-5-337

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Lohse, M., Bolger, A. M., Nagel, A., Fernie, A. R., Lunn, J. E., Stitt, M., et al. (2012). RobiNA: a user-friendly, integrated software solution for RNA-seq-based transcriptomics. Nucleic Acids Res. 40, W622–W627. doi: 10.1093/nar/gks540

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

MacManes, M. D. (2014). On the optimal trimming of high-throughput mRNA sequence data. Front. Genet. 5:13. doi: 10.3389/fgene.2014.00013

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Martin, M. (2011). Cutadapt removes adapter sequences from high-throughput sequencing reads. EMBnet. J. 17, 10–12. doi: 10.14806/ej.17.1.200

CrossRef Full Text

Mundry, M., Bornberg-Bauer, E., Sammeth, M., and Feulner, P. G. (2012). Evaluating characteristics of de novo assembly software on 454 transcriptome data: a simulation approach. PLoS ONE 7:e31410. doi: 10.1371/journal.pone.0031410

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Parra, G., Bradnam, K., and Korf, I. (2007). CEGMA: a pipeline to accurately annotate core genes in eukaryotic genomes. Bioinformatics 23, 1061–1067. doi: 10.1093/bioinformatics/btm071

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Robertson, G., Schein, J., Chiu, R., Corbett, R., Field, M., Jackman, S. D., et al. (2010). De novo assembly and analysis of RNA-seq data. Nat. Methods 7, 909–912. doi: 10.1038/nmeth.1517

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Schulz, M. H., Zerbino, D. R., Vingron, M., and Birney, E. (2012). Oases: robust de novo RNA-seq assembly across the dynamic range of expression levels. Bioinformatics 28, 1086–1092. doi: 10.1093/bioinformatics/bts094

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Simpson, J. T., Wong, K., Jackman, S. D., Schein, J. E., Jones, S. J., and Birol, I. (2009). ABySS: a parallel assembler for short read sequence data. Genome Res. 19, 1117–1123. doi: 10.1101/gr.089532.108

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Surget-Groba, Y., and Montoya-Burgos, J. I. (2010). Optimization of de novo transcriptome assembly from next-generation sequencing data. Genome Res. 20, 1432–1440. doi: 10.1101/gr.103846.109

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Zerbino, D. R. (2010). Using the velvet de novo assembler for short-read sequencing technologies. Curr. Protoc. Bioinformatics Chapter 11: Unit 11.5. doi: 10.1002/0471250953.bi1105s31

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Zerbino, D. R., and Birney, E. (2008). Velvet: algorithms for de novo short read assembly using de Bruijn graphs. Genome Res. 18, 821–829. doi: 10.1101/gr.074492.107

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Zhao, Q. Y., Wang, Y., Kong, Y. M., Luo, D., Li, X., and Hao, P. (2011). Optimizing de novo transcriptome assembly from short-read RNA-seq data: a comparative study. BMC Bioinformatics 12(Suppl. 14):S2. doi: 10.1186/1471-2105-12-S14-S2

Pubmed Abstract | Pubmed Full Text | CrossRef Full Text

Keywords: RNA-seq, de novo transcriptome, assembly, Illumina, high-throughput sequencing

Citation: Moreton J, Dunham SP and Emes RD (2014) A consensus approach to vertebrate de novo transcriptome assembly from RNA-seq data: assembly of the duck (Anas platyrhynchos) transcriptome. Front. Genet. 5:190. doi: 10.3389/fgene.2014.00190

Received: 17 April 2014; Accepted: 09 June 2014;
Published online: 25 June 2014.

Edited by:

Chun Liang, Miami University, USA

Reviewed by:

Dhananjai M. Rao, Miami University, USA
Andor J. Kiss, Miami University, USA
Sujai Kumar, University of Oxford, UK

Copyright © 2014 Moreton, Dunham and Emes. This is an open-access article distributed under the terms of the Creative Commons Attribution License (CC BY). The use, distribution or reproduction in other forums is permitted, provided the original author(s) or licensor are credited and that the original publication in this journal is cited, in accordance with accepted academic practice. No use, distribution or reproduction is permitted which does not comply with these terms.

*Correspondence: Joanna Moreton, Advanced Data Analysis Centre, School of Veterinary Medicine and Science, University of Nottingham, Sutton Bonington Campus, Loughborough, Leicestershire, LE12 5RD, UK e-mail: joanna.moreton@nottingham.ac.uk

Disclaimer: All claims expressed in this article are solely those of the authors and do not necessarily represent those of their affiliated organizations, or those of the publisher, the editors and the reviewers. Any product that may be evaluated in this article or claim that may be made by its manufacturer is not guaranteed or endorsed by the publisher.