Skip to main content

FUSIM: a software tool for simulating fusion transcripts

Abstract

Background

Gene fusions are the result of chromosomal aberrations and encode chimeric RNA (fusion transcripts) that play an important role in cancer genesis. Recent advances in high throughput transcriptome sequencing have given rise to computational methods for new fusion discovery. The ability to simulate fusion transcripts is essential for testing and improving those tools.

Results

To facilitate this need, we developed FUSIM (FUsion SIMulator), a software tool for simulating fusion transcripts. The simulation of events known to create fusion genes and their resulting chimeric proteins is supported, including inter-chromosome translocation, trans-splicing, complex chromosomal rearrangements, and transcriptional read through events.

Conclusions

FUSIM provides the ability to assemble a dataset of fusion transcripts useful for testing and benchmarking applications in fusion gene discovery.

Background

Chromosome aberrations and their corresponding gene fusions play an important role in carcinogenesis and cancer morbidity [1]. The identification of fusion genes such as TMPRSS2-ERG [2], EML4-ALK [3], and BCR-ABL1 [4], have led to successful diagnostic biomarkers and therapeutic targets. Thus methods for detecting fusion genes and their corresponding chimeric proteins have major clinical significance. Recent advances in next-generation sequencing (NGS) and high-throughput transcriptome sequencing (RNA-Seq) have paved the way for new methods in fusion gene discovery. One of the major challenges in identifying novel fusion transcripts is controlling the high false positive rate. The majority of methods in recent publications utilizing RNA-Seq data [5-10], employ advanced filtering steps to eliminate false positives and nominate a set of potential fusion candidates. However, fusion validation involves a substantial amount of manual effort requiring the design of complex PCR primers which can significantly drive up costs. As a result, only a portion of predicted fusion events subject to experimental validation. Measuring the accuracy of these methods is becoming increasingly important to help improve future algorithm development. To help facilitate this need, we developed FUSIM, a software tool for simulating fusion transcripts from gene models. An advanced set of features are available for controlling fusion transcript simulation modeled after characteristics of gene fusions in vivo. FUSIM enables comprehensive testing in silico of fusion discovery methods in transcriptome sequencing data. FUSIM is open source software written in Java and runs on any platform supporting Java version 1.6 and above.

Implementation

Input

FUSIM requires as input, the number of fusion transcripts to generate and a gene model file in UCSC GenePred table format [11]. General Feature Format (GFF [12]) and Gene Transfer Format (GTF [13]) files are also supported using FUSIM’s built in GTF-to-genePred converter. FUSIM also requires an faidx-indexed reference genome file for use in outputting raw fusion sequences. Reference genomes in FASTA format [14] can be converted to faidx-indexed format using SAMtools [15]. FUSIM can optionally simulate fusion transcripts based on the expression levels of genes found in experimental data. If this option is selected, a file of RNA-Seq read alignments in Binary Alignment/Map (BAM [15]) format is required.

Gene selection

FUSIM supports two modes for selecting genes to be included in fusion transcripts. The first mode (default) randomly selects genes from the provided gene model using a discrete uniform distribution where each gene has equal weight 1 n . The second mode selects genes using a background dataset of RNA-Seq read alignments in BAM format. The background RNA-Seq dataset is first preprocessed using the provided gene model and for each gene, the reads per kilobase of exon model per million mapped reads (RPKM [16]) is computed. A default RPKM cutoff of 0.2 is used to filter out genes with low expression and can be optionally configured by the user. Genes are then selected using one of the three methods: uniform, empirical, or binned. The uniform method simply selects genes at random having an RPKM value above the cutoff. The empirical method randomly selects genes based on the empirical distribution of RPKM values in the background RNA-Seq dataset. The empirical distribution is a non-parametric estimation of the probability distribution function of RPKM values. Our (histogram) estimator is a piecewise constant function where the height of the function is proportional to the number of observations in each bin. The number of bins is a smoothing parameter and can be chosen according to many rules. For simplicity, we choose k = n where n is the number of genes (RPKM values). Alternatively, FUSIM also offers the Sturges’ method where k=log2n+1. The binned method sorts genes into m bins using their RPKM values, where m is the number of fusions to generate. A set of genes are then selected once from each bin, covering the dynamic range of gene expression contained in the background RNA-Seq dataset. The gene selection modes along with their corresponding options in FUSIM are summarized in Table 1.

Table 1 Gene selection options in FUSIM

The filters to select genes by gene ID, transcript ID, or chromosome are also supported. They can be set globally (i.e. specifying all genes within a fusion) or set on a per gene basis. For example, specifying only the first gene in a fusion to BCR or both the first and second gene to BCR and ABL1 respectively. This provides the ability to specify simulation of fusion transcripts on genes or chromosomes of interest.

Types of fusions

Multiple types of fusion transcripts are supported in FUSIM. Based on the number of genes involved per fusion, the fusion types are classified as self, hybrid, complex which involves 1, 2, and 3 genes respectively (Figure 1b). According to chromosome locations and strand, fusion types are classified as CTX (inter-chromosome events), ITX (intra-chromsome events with different strands), DUP (tandem duplication), and DEL (deletion). Complex chromosomal rearrangements (CCRs) are examples of complex fusions involving at least three breakpoints on two or more chromosomes [17]. Read through events are also supported as a special case of DEL with two adjacent genes on the same strand fused together. The distribution of known gene fusion events in various tissues and/or diseases can be derived from online databases such as ChimerDB [18]. For example, the proportion of CTX, ITX, DUP and DEL in all known cancer fusion events is 88.3%, 4.8%, 5.5% and 1.4%, respectively. FUSIM enables users to create simulated datasets based on the distribution of known fusion catalogs in the specific tissue/disease type of their study (if available).

Figure 1
figure 1

Fusion transcript simulation. Example of fusion transcript simulation. (a) Original transcripts of three selected genes NPS, PR44, ATP5I. Boxes represent exons and solid lines refer to introns. (b) Illustration of three basic types of fusion transcripts. Hybrid fusions use exons from two distinct genes, Self fusions join exons from a single gene, Complex fusions use exons from three distinct genes. (c) Example of the available options for controlling fusion transcript generation. Split exons randomly selects breakpoints in the exons involved. Keep exon boundary forces fusion breakpoints to fall on exon boundaries. CDS only creates fusions using exons within the coding sequence region. Foreign insertion inserts a randomly generated sequence between fusion breakpoints. Auto-correct orientation forces FUSIM to correct the orientation of exons.

Options for controlling fusions

After selecting a set of genes using the methods outlined in the previous section, fusion transcripts are created by randomly choosing a breakpoint in each gene and fusing them together. Breakpoints are created by randomly selecting n number of consecutive exons from the start or end of each gene.

FUSIM provides an advanced set of options to further control various aspects of fusion transcript simulation (Figure 1c). By default, genes are fused together by splitting the joined exons in random positions (split exons). The keep exon boundary option will fuse genes exclusively on exon boundaries. The CDS only option creates fusions using exons within the coding sequence region, by default all exons are considered. The foreign insertion option inserts a randomly generated sequence between the fusion breakpoint. FUSIM can be set to auto-correct the orientation of the resulting fusion transcript if genes are located on different strands. This is done by reverse complementing the selected exons to match the orientation of the first gene in the fusion. By default, FUSIM creates in-frame fusion transcripts preserving the reading frame. Generating out-of-frame fusion transcripts disrupting the reading frame is also supported.

Output

FUSIM outputs simulated fusion transcripts in both plain text and FASTA format as shown in Figure 2. The text output format used by FUSIM is very similar to UCSC GenePred (refFlat) format and can be easily parsed with exiting software.

Figure 2
figure 2

Example FUSIM output. Example of simulated fusion transcripts generated by FUSIM. (a) Text output of two simulated fusion transcripts NPS-RPL38 (inter-chromosome hybrid fusion) and MMP14-LRP10 (readthrough fusion). (b) FASTA output of the raw sequence data showing fusion junctions. (c) Results of BLAT search using the FASTA sequences in (b) validating FUSIM output. The black square boxes represent the exons from RefSeq genes and the colored boxes represent the exons from the gene fusion generated by FUSIM.

Certain fusion discovery tools require sequencing read data in FASTQ [19] format as input. FUSIM includes wrapper scripts for simulating next generation sequencing reads from the generated fusion transcripts using ART [20]. The resulting FASTQ files can also be aligned back to a reference genome and optionally merged with existing alignment data, useful for injecting reads from simulated fusions into background datasets.

Conclusion

One of the main difficulties in testing fusion discovery methods is the lack of a golden standard dataset of fusion transcripts which can be used to accurately compare performance. FUSIM aims to provide a convenient way to rapidly generate datasets of simulated fusion transcripts for comprehensive comparison across fusion discovery methods. The advanced options in FUSIM allow for construction of simulated fusion transcripts that model the origins of gene fusions in vivo.

Availability and requirements

Project name: FUSIMProject home page:http://aebruno.github.com/fusim/Operating system(s): Platform independentProgramming language: JavaOther requirements: Java 1.6 or higherLicense: Apache License version 2.0Any restrictions to use by non-academics: none

Abbreviations

GenePred:

Gene Prediction Track Format

GFF:

General Feature Format

GTF:

Gene Transfer Format

BAM:

Binary Alignment/Map

RPKM:

reads per kilobase of exon model per million mapped reads.

References

  1. Mitelman F, Johansson B, Mertens F: The impact of translocations and gene fusions on cancer causation. Nat Rev Cancer 2007,7(4):233-245. 10.1038/nrc2091

    Article  CAS  PubMed  Google Scholar 

  2. Tomlins SA, Rhodes DR, Perner S, Dhanasekaran SM, Mehra R, Sun XW, Varambally S, Cao X, Tchinda J, Kuefer R, Lee C, Montie JE, Shah RB, Pienta KJ, Rubin MA, Chinnaiyan AM: Recurrent fusion of TMPRSS2 and ETS transcription factor genes in prostate cancer. Science 2005,310(5748):644-648. 10.1126/science.1117679

    Article  CAS  PubMed  Google Scholar 

  3. Soda M, Choi YL, Enomoto M, Takada S, Yamashita Y, Ishikawa S, ichiro Fujiwara S, Watanabe H, Kurashina K, Hatanaka H, Bando M, Ohno S, Ishikawa Y, Aburatani H, Niki T, Sohara Y, Sugiyama Y, Mano H: Identification of the transforming EML4-ALK fusion gene in non-small-cell lung cancer. Nature 2007,448(7153):561-566. 10.1038/nature05945

    Article  CAS  PubMed  Google Scholar 

  4. Rowley JD: Chromosome translocations: dangerous liaisons revisited. Nat Rev Cancer 2001,1(3):245-250. 10.1038/35106108

    Article  CAS  PubMed  Google Scholar 

  5. Maher CA, Kumar-Sinha C, Cao X, Kalyana-Sundaram S, Han B, Jing X, Sam L, Barrette T, Palanisamy N, Chinnaiyan AM: Transcriptome sequencing to detect gene fusions in cancer. Nature 2009,458(7234):97-101. 10.1038/nature07638

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  6. Iyer MK, Chinnaiyan AM, Maher CA: ChimeraScan: a tool for identifying chimeric transcription in sequencing data. Bioinformatics 2011,27(20):2903-2904. 10.1093/bioinformatics/btr467

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  7. McPherson A, Hormozdiari F, Zayed A, Giuliany R, Ha G, Sun MGF, Griffith M, Moussavi AH, Senz J, Melnyk N, Pacheco M, Marra MA, Hirst M, Nielsen TO, Sahinalp SC, Huntsman D, Shah SP: deFuse: an algorithm for gene fusion discovery in tumor RNA-Seq data. PLoS Comput Biol 2011,7(5):e1001138. 10.1371/journal.pcbi.1001138

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  8. Ge H, Liu K, Juan T, Fang F, Newman M, Hoeck W: FusionMap: detecting fusion genes from next-generation sequencing data at base-pair resolution. Bioinformatics 2011,27(14):1922-1928. 10.1093/bioinformatics/btr310

    Article  CAS  PubMed  Google Scholar 

  9. Asmann YW, Hossain A, Necela BM, Middha S, Kalari KR, Sun Z, Chai HS, Williamson DW, Radisky D, Schroth GP, Kocher JPA, Perez EA, Thompson EA: A novel bioinformatics pipeline for identification and characterization of fusion transcripts in breast cancer and normal cell lines. Nucleic Acids Res 2011,39(15):e100. 10.1093/nar/gkr362

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  10. Li Y, Chien J, Smith DI, Ma J: FusionHunter: identifying fusion transcripts in cancer using paired-end RNA-seq. Bioinformatics 2011,27(12):1708-1710. 10.1093/bioinformatics/btr265

    Article  CAS  PubMed  Google Scholar 

  11. GenePred Table Format [http://genome.ucsc.edu/FAQ/FAQformat.html#format9] []

  12. Gene Feature Format [http://www.sanger.ac.uk/resources/software/gff/] []

  13. Gene Transfer Format [http://mblab.wustl.edu/GTF22.html] []

  14. Pearson WR, Lipman DJ: Improved tools for biological sequence comparison. Proc Natl Acad Sci U S A 1988,85(8):2444-2448. 10.1073/pnas.85.8.2444

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  15. Li H, Handsaker B, Wysoker A, Fennell T, Ruan J, Homer N, Marth G, Abecasis G, Durbin R, Subgroup GPDP: The Sequence Alignment/Map format and SAMtools. Bioinformatics 2009,25(16):2078-2079. 10.1093/bioinformatics/btp352

    Article  PubMed Central  PubMed  Google Scholar 

  16. Mortazavi A, Williams BA, McCue K, Schaeffer L, Wold B: Mapping and quantifying mammalian transcriptomes by RNA-Seq. Nat Methods 2008,5(7):621-628. 10.1038/nmeth.1226

    Article  CAS  PubMed  Google Scholar 

  17. Pellestor F, Anahory T, Lefort G, Puechberty J, Liehr T, Hédon B, Sarda P: Complex chromosomal rearrangements: origin and meiotic behavior. Hum Reprod Update 2011,17(4):476-494. 10.1093/humupd/dmr010

    Article  CAS  PubMed  Google Scholar 

  18. Kim P, Yoon S, Kim N, Lee S, Ko M, Lee H, Kang H, Kim J, Lee S: ChimerDB 2.0-a knowledgebase for fusion genes updated. Nucleic Acids Res 2010,38(Database issue):D81-D85. 10.1093/nar/gkp982

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  19. Cock PJA, Fields CJ, Goto N, Heuer ML, Rice PM: The Sanger FASTQ file format for sequences with quality scores, and the Solexa/Illumina FASTQ variants. Nucleic Acids Res 2010,38(6):1767-1771. 10.1093/nar/gkp1137

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  20. Huang W, Li L, Myers JR, Marth GT: ART: a next-generation sequencing read simulator. Bioinformatics 2012,28(4):593-594. 10.1093/bioinformatics/btr708

    Article  PubMed Central  PubMed  Google Scholar 

Download references

Acknowledgements

We wish to thank L. Shepherd, Q. Hu, P. Colson, M. Zhu, Y. Yang and et al for testing the FUSIM software and providing helpful comments.

Author information

Authors and Affiliations

Authors

Corresponding authors

Correspondence to Andrew E Bruno, Jianmin Wang or Song Liu.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors’ contributions

AEB designed and implemented the software. AEB also drafted the manuscript. SL and JW conceived of the project. SL, JW, MQ, and JCM provided feedback on the software development and manuscript. AEB, JCM, JW, MQ, and SL tested the software. All authors read and approved the final manuscript.

Authors’ original submitted files for images

Below are the links to the authors’ original submitted files for images.

Authors’ original file for figure 1

Authors’ original file for figure 2

Rights and permissions

This article is published under license to BioMed Central Ltd. This is an Open Access article distributed under the terms of the Creative Commons Attribution License (http://creativecommons.org/licenses/by/2.0), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited.

Reprints and permissions

About this article

Cite this article

Bruno, A.E., Miecznikowski, J.C., Qin, M. et al. FUSIM: a software tool for simulating fusion transcripts. BMC Bioinformatics 14, 13 (2013). https://doi.org/10.1186/1471-2105-14-13

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-14-13

Keywords