Summary
Here, we present FusionInspector for in silico characterization and interpretation of candidate fusion transcripts from RNA sequencing (RNA-seq) and exploration of their sequence and expression characteristics. We applied FusionInspector to thousands of tumor and normal transcriptomes and identified statistical and experimental features enriched among biologically impactful fusions. Through clustering and machine learning, we identified large collections of fusions potentially relevant to tumor and normal biological processes. We show that biologically relevant fusions are enriched for relatively high expression of the fusion transcript, imbalanced fusion allelic ratios, and canonical splicing patterns, and are deficient in sequence microhomologies between partner genes. We demonstrate that FusionInspector accurately validates fusion transcripts in silico and helps characterize numerous understudied fusions in tumor and normal tissue samples. FusionInspector is freely available as open source for screening, characterization, and visualization of candidate fusions via RNA-seq, and facilitates transparent explanation and interpretation of machine-learning predictions and their experimental sources.
Keywords: RNA-seq, fusion, cancer, FusionInspector, STAR-Fusion, Trinity
Graphical abstract
Highlights
-
•
FusionInspector software for supervised analysis of candidate fusion transcripts
-
•
Clustering of recurrent fusion transcripts resolves biologically relevant fusions
-
•
Distinguishing characteristics of fusion transcripts in tumor and normal tissues
Motivation
Gene fusions play a key role as driver oncogenes in tumors, and their reliable discovery and detection are important for cancer research, diagnostics, prognostics, and guiding personalized therapy. While discovering gene fusions from genome sequencing can be laborious and costly, the resulting fusion transcripts can be recovered from RNA-sequencing data of tumor and normal samples. However, alleged and putative fusion transcripts can also arise from multiple sources other than chromosomal rearrangements, including cis- or trans-splicing events, experimental artifacts during RNA sequencing, or computational errors of transcriptome reconstruction methods. Understanding how to discern, interpret, categorize, and verify predicted fusion transcripts is essential for consideration in clinical settings and prioritization for further research.
Haas et al. present FusionInspector, a method for in silico characterization and interpretation of candidate fusion transcripts identified via RNA sequencing. Applied to thousands of tumor and normal transcriptomes, FusionInspector identified numerous likely biologically relevant fusions with potential roles in cancer or normal cellular biology.
Introduction
Gene fusions are intensely studied for their relevance to disease and normal cellular biology. In cancer, gene fusions typically result from chromosomal rearrangements, including well-known drivers of cancer, such as BCR::ABL1 in chronic myelogenous leukemia (CML),1,2 TMPRSS2::ERG in prostate cancer,3,4 and SS18::SSX1 or SS18::SSX2 in synovial sarcoma.5,6 Charting the diversity of fusion transcripts present in tumor and normal tissue is important for our basic understanding of the complexity and biological function of the transcriptome in normal and disease states, molecular diagnostics of cancer patients, and neoantigen discovery for targeting in personalized immunotherapy with cancer vaccines or T cell therapy.7,8
The structural rearrangements leading to gene fusions can be detected or inferred through whole-genome sequencing (WGS) or from the presence of “fusion transcripts” in whole-transcriptome RNA sequencing (RNA-seq).9,10 Given the easier and less costly nature of RNA-seq compared with WGS, and the effective methods for transcript assembly, RNA-seq has emerged as a leading experimental method for fusion transcript discovery and detection in both cancer research and molecular diagnostics. Dozens of computational tools have been developed to mine fusion transcripts from RNA-seq data (as referenced in Haas et al.11), and there have been multiple efforts to build catalogs of fusions across tumor and normal tissues.12,13,14,15,16,17 In general, tumor-specific fusion transcripts are presumed to derive from chromosomal rearrangements, whereas fusions identified in normal samples are more likely to be derived from normal karyotypes, thus reflecting other underlying causes, such as read-through transcription and cis- or trans-spliced products.
Nevertheless, predicting fusions from RNA-seq data is challenging, and the various methods developed to predict fusion products from RNA-seq vary tremendously in their accuracy for fusion detection, leading to both false positives and false negatives.11,18,19 False positives can be due to experimental artifacts that arise during reverse transcription or PCR amplification or computational mismapping of reads to target gene sequences,20 as well as specific differences in prediction tools. Moreover, as sequencing depth increases, the probability of detecting rare reads that support a fusion transcript prediction increases, due to either lab artifacts or real, low-rate trans-splicing of questionable functional relevance. Thus, there is an urgent need to understand the features that drive fusion detection and to generate high-quality catalogs of well-supported fusions.
Here we describe FusionInspector (Figure 1), a method to assess and document the evidence for fusions. While other methods have previously been developed for fusion visualization,21,22,23,24,25 FusionInspector includes modules for supervised detection of fusion transcripts and comparing fusion transcripts with corresponding unfused fusion partners, and aims to differentiate likely biologically relevant fusions from likely experimental or bioinformatic artifacts. FusionInspector reassesses the read alignment evidence supporting targeted candidate fusion transcripts, comparing the relative alignment evidence for a fusion transcript with counter-evidence for its unfused partner transcripts. FusionInspector further evaluates the fusion transcript breakpoints in relation to sequence features representative of likely experimental and bioinformatic artifacts,26,27 including canonical splicing sequences, reference exon gene structures, and regions of microhomology between partner genes. Through reports, interactive visualizations, and classification, FusionInspector aims to in silico assess fusions for their likely validity and assist researchers in reasoning about the quantity and quality of the evidence supporting predicted fusions, to differentiate likely artifacts from fusions with characteristics similar to biologically relevant fusions known to occur in tumor and normal tissues. While potential oncogenicity and structural rearrangements may often be implied by tumor vs. normal sample prevalence and chromosomal loci for fusion gene partners, respectively, FusionInspector makes no assertions regarding oncogenicity or mechanism (genome rearrangement vs. cis- or trans-splicing) by which biologically relevant fusions may be derived.
We applied FusionInspector to assess recurrently predicted fusions in tumor and normal tissues, gathering insights into fusion transcript diversity and devising machine-learning methods for fusion classification (Figure S1A). We first applied FusionInspector to examine recurrently predicted fusions in tumor and normal tissues to compute sequence and expression features, from which we next generated clusters of fusion variants with similar characteristics. We then identified fusion clusters that are enriched for known biologically relevant fusions, and others as likely artifacts. From these fusion clusters, we trained a classifier to automatically predict fusion instances as likely biologically relevant, likely artifactual, or other type. Finally, we applied FusionInspector on additional predicted instances of fusion transcripts that were clustered with biologically relevant fusions and explored, classified, and prioritized these transcripts to identify additional relevant candidates in tumor and normal transcriptomes. Our application discovered a cluster of fusion transcripts heavily enriched for known cancer fusions and other fusions of interest. FusionInspector is freely available as open-source software at https://github.com/FusionInspector/FusionInspector/wiki.
Results
Development of FusionInspector for in silico evaluation of predicted fusion transcripts
FusionInspector (Figure 1) performs a supervised in silico evaluation of a specified set of candidate fusions, predicted from either RNA-seq data or from a user-defined panel. FusionInspector captures all read alignments in the RNA-seq that provide evidence for the specified fusions or for the unfused partner genes, and further explores the candidate fusion genes for regions of microhomology (defined as short identical sequence matches of length k [here k = 10]), and the proximity of microhomologies to putative fusion breakpoints.
To capture evidence supporting candidate fusions, FusionInspector identifies those reads that align concordantly between fusion genes as juxtaposed in their fused orientation and provide concordant alignments that span the two genes in this rearranged context. There are two types of fusion-supporting alignments: (1) split reads that define the fusion breakpoint, and (2) spanning fragments, where each paired-end read aligns to an opposite partner gene and the fragment bridges the fusion breakpoint (Figure 1). FusionInspector leverages the STAR aligner,28 which we enhanced here to support FusionInspector’s mode of action. As input to STAR, we provide the entire reference genome along with a set of fusion contigs constructed by FusionInspector (based on the list of specified fusion candidates), and STAR aligns reads to the combined genome targets and reports those aligned to the fusion contigs for further evaluation by FusionInspector (STAR Methods).
Next, FusionInspector computes several features that are associated with the fusion based on these alignments to assist in their evaluation. First, it uses the normalized number of reads exclusively supporting each fusion variant as a proxy for the expression of the fusion transcript (similarly, read alignments overlapping the fusion breakpoint and exclusively supporting the unfused partner genes are a proxy for the expression levels of the unfused partner genes). Second, it computes the fusion allelic ratio (FAR) for the fusion with respect to each (5′ or 3′) partner transcript (5′-FAR and 3′-FAR) as the ratio of mutually exclusive reads supporting the fusion variant vs. each unfused partner gene (Figures 1 and S1C). Third, it examines fusion breakpoints inferred from the read alignments for canonical dinucleotide splice sites at boundaries of the breakpoints in each partner gene and for agreement with available reference gene structure annotations. When there is evidence that supports multiple fusion transcript variants for a given fusion gene occurrence, FusionInspector uses an expectation-maximization-based algorithm to fractionally assign mutually compatible spanning fragments to the corresponding variants (STAR Methods). It then filters fusion variant candidates according to minimum evidence requirements (default settings require at least one split read to define the junction breakpoint, and at least 25 aligned bases supported by at least one read on both sides of the fusion breakpoint; STAR Methods). Finally, it captures microhomologies between putative fusion genes and determines the proximity of a fusion breakpoint to the nearest site of microhomology.
For clarity, we will use the following definitions when reporting on fusions cataloged among samples. “Fusion” refers to two genes, geneA and geneB, where there exists a fusion transcript involving exons from geneA and geneB, ordered respectively, and written as geneA::geneB according to the Human Genome Organization’s (HUGO) Gene Nomenclature Committee (HGNC) nomenclature for fusion genes.29 A “fusion occurrence” corresponds to a fusion identified in an individual sample, defined by the tuple (fusion, sample). A “fusion transcript” or “fusion variant” (used interchangeably) represents a fusion occurrence with a unique breakpoint (e.g., splicing isoform), defined by the unique tuple (fusion, sample, breakpoint coordinates). The primary fusion variant is defined as the variant with the highest expression level within an occurrence. Fusion occurrences and primary fusion variants are considered equivalent, and these terms are used interchangeably.
Assessment of fusions using FusionInspector
By evaluating alignments to the modeled fusion contigs, FusionInspector demonstrates high sensitivity and specificity in supervised fusion detection, as we show for validated fusions in four well-studied breast cancer cell lines: BT474, KPL4, MCF7, and SKBR3. In our earlier study, 46 experimentally validated fusions were correctly predicted by at least one of 24 different fusion prediction methods.11 When FusionInspector was applied to the same data, it correctly identified each of these fusions in the relevant sample (Figure 2 and Table S1), with no false positives.
Using sequence and expression attributes of fusions and known characteristics of biologically relevant fusions (see below), FusionInspector further predicts whether each in silico validated fusion variant candidate (i.e., a fusion candidate evaluated by FusionInspector as having fusion read support evidence) is likely to be biologically relevant or alternatively has features consistent with experimental or bioinformatic fusion artifacts.
We illustrate these features in the context of two contrasting examples of fusion types (Figure 3). Fusion EML4:ALK, a known cancer driver prevalent in lung adenocarcinoma,30,31 has evidence of multiple transcript variant structures, and while microhomologies are found between the EML4 and ALK genes they tend to be distal from the fusion variant breakpoints (Figure 3A). The EML4::ALK fusion variant breakpoints are all found at consensus dinucleotide splice sites that coincide with exon boundaries of reference gene structure annotations. In contrast, FusionInspector captures many reads supporting a putative fusion KRT13::KRT4, but the breakpoints inferred from split-read alignments mostly have non-consensus dinucleotide splice sites and coincide with sites of microhomology; additionally, split reads with consensus dinucleotide splice sites mostly do not coincide with reference exon boundaries (Figure 3B). Because KRT13 and KRT4 are only distantly related with no easily detected nucleotide-level sequence conservation, their fusion may not be discarded by many fusion transcript predictors. However, given that most fusion evidence coincided with sites of microhomology and the lack of consensus splicing at breakpoints, FusionInspector infers most putative KRT13::KRT4 fusion variants to be artifactual. Another particularly compelling example of a similarly misleading and likely artifactual fusion is COL1A1::FN1, which is detected as prevalent in cancer-associated fibroblast cell lines (Figure S2). Further consideration of fusion and partner gene expression levels can aid in evaluating and prioritizing fusion candidates for further study, as we pursue below.
Clustering of recurrent fusion transcripts via FusionInspector attributes resolves COSMIC-like and artifact-like fusions
We first applied FusionInspector to examine recurrent fusion transcripts based on poly(A)-stranded RNA-seq from tumors (from The Cancer Genome Atlas [TCGA]32) and corresponding healthy tissue (from TCGA and Genotype-Tissue Expression [GTEx]33). To generate an initial comprehensive catalog of fusion variants in tumor and normal tissues, we predicted fusion transcripts with STAR-Fusion (v1.7) across 9,426 tumor and 707 normal samples from TCGA, and 8,375 normal samples from GTEx (Table S2). We initially applied lenient fusion evidence requirements to maximize sensitivity (STAR Methods). As a result, putative fusion transcripts were detected in nearly all tumor and normal samples. After applying a minimum expression level threshold (0.1 fusion fragments per million [FFPM]), we detected a significantly higher number of fusion occurrences in tumors vs. paired normal samples in several TCGA tumor types (Figure S3A), although there were similar median numbers of predicted fusion occurrences per sample type in TCGA tumor and GTEx normal samples (t test, p = 0.5, Figure S3B). We readily identified known cancer fusions included in the COSMIC fusion collection34,35 (“COSMIC fusions,” Figure 4A) according to known disease associations and prevalence, such as TMPRSS2::ERG identified in roughly half of prostate cancers,3 FGFR3::TACC3 in glioblastoma,36 and PML::RARA in the acute promyelocytic leukemia subtype of acute myeloid leukemia (AML).37 COSMIC fusions were more highly expressed than most predicted fusions, which had low estimated expression levels and few supporting reads (Figures 4B–4D).
Next, we used FusionInspector to examine the sequence and expression features of fusion transcripts that were recurrently detected across tumor and/or normal samples in order to distinguish biologically impactful fusions (akin to the COSMIC fusions) from experimental or computational artifacts, or from low levels of cis- or trans-splicing from highly expressed genes. To this end, we analyzed all 53,240 predicted fusion variants (38,591 fusion occurrences plus 14,649 alternative fusion variants) from 628 TCGA and 530 GTEx representative samples (STAR Methods). For each fusion candidate, FusionInspector identified the number of reads supporting the fusion variant and those supporting the unfused partner genes at putative breakpoints, identified regions of microhomology between partner genes, and determined the following features: inferred fusion expression level (FFPM), 5′ and 3′ fusion allelic ratios (5′-FAR, 3′-FAR), 5′ and 3′ unfused gene expression levels (5′-counter-FFPM and 3′-counter-FFPM), presence of consensus vs. non-consensus dinucleotide splice sites at fusion breakpoints, agreement or disagreement with reference gene structure exon boundaries at splice junctions, number of microhomologies observed between the two partner genes, and the distance of each inferred fusion breakpoint to the nearest site of microhomology.
To distinguish fusion artifacts from those with features consistent with biologically impactful fusions, we clustered fusion variants by their feature profiles (Figures 5A and S4; Table S3; STAR Methods). Clustering produced 61 high-granularity clusters, each containing an abundance of fusions identified in both TCGA and GTEx samples and distinguishable by feature attributes (Figures S5A–S5L). We further grouped these fusion variant clusters by hierarchical clustering according to median fusion attribute values in each fine cluster (Figure 5B). We then focused on examining clusters enriched for COSMIC fusions as a proxy for biologically impactful fusions, exploring those fusions with sequence and expression characteristics similar to those of COSMIC fusions, irrespective of potential genome rearrangement characteristics or known oncogenic roles.
One fusion cluster (C4) was significantly enriched with COSMIC fusions, harboring 57% of our detected instances of COSMIC fusion occurrences among these samples, but only 4% of all fusion occurrences (p < 10−90, Fisher’s exact one-sided test) (Figure 5B). Fusion variants in this cluster had splice breakpoints consistent with consensus splice sites and matching known reference gene structure exon boundaries, were relatively highly expressed, and were deficient in microhomologies between fusion partner genes. Most of the COSMIC fusions in C4 also have a 3′-FAR that exceeds the 5′-FAR, consistent with the fusion transcript being driven from an active 5′ partner’s promoter and a 3′ unfused partner expressed at lower levels (Figure S5M). Sixteen additional clusters, all but one (C10) of which are members of one large hierarchical cluster with related features, had at least two COSMIC fusion occurrences per cluster and spanned 34% of the fusion occurrences overall, including 37% of all COSMIC fusion occurrences.
Conversely, other fusion clusters, spanning 3% of all fusion occurrences and no COSMIC fusion occurrences, had features indicative of experimental or computational artifacts, especially enrichment in microhomologies that could confound alignment or contribute to reverse transcriptase mispriming. We thus consider those fusion variants as putative artifacts. Of the 3% of all fusion occurrences encompassed by these clusters, two-thirds (2% of all fusion occurrences) had moderately to highly expressed partner genes, suggesting origination from reverse transcriptase mispriming, and the remainder had little evidence for partner gene expression, suggesting read misalignment artifacts. The low portion of such presumed artifacts is a testament to STAR-Fusion’s rigorous filtering.11 A further 1% of fusions involved highly expressed partner genes, where the detected fusion represented a small fraction of the total expression from these loci. These fusions may result from low levels of cis- or trans-splicing from the highly expressed partner genes.
A fusion classifier allows targeted screening of predicted COSMIC-like fusions
We reasoned that the set of 1,511 predicted fusion occurrences (835 distinct fusions) that were members of the COSMIC-enriched cluster C4 are likely enriched for fusions of functional significance and should be prioritized for further study. Some are already known to be relevant to cancer but not yet included in the COSMIC database, such as EGFR::SEPT14,39, PVT1::MYC,40,41,42 and TPM3::NTRK1.43 Others are reciprocal fusions for COSMIC fusions that could result from balanced translocations, including reciprocal ABL1::BCR1 of COSMIC BCR1::ABL1, BRAF::SND1 of COSMIC SND1::BRAF, and PPARG::PAX8 of COSMIC PAX8::PPARG. This fusion cluster is also enriched for fusions exclusively identified in pancreatic tissue (explored below).
To gain further insights into the characteristics of the COSMIC-like fusions in C4, we first screened additional TCGA and GTEx samples to characterize additional occurrences of C4 representative fusions. We refocused FusionInspector on 236 C4+ key fusions (231 C4 recurrent fusion gene pairs including 26 recurrent COSMIC fusions, plus another five recurrent COSMIC fusions having all occurrences localized outside of C4; STAR Methods and Table S444). We screened each of 2,764 TCGA and 1,009 GTEx representative samples for these 236 fusions (STAR Methods), collecting FusionInspector in silico validations and attributes for 37,211 additional fusion occurrences (Figures 6 and S6A–S6E; Table S4), and ranked fusions by the difference in their initial detected prevalence in tumors vs. normal samples.
To determine whether additional occurrences of these fusions have characteristics consistent with COSMIC-like C4 fusions, are artifact-like, or belong to another category, we trained a random forest classifier to predict the labels of each of the earlier-defined 61 Leiden clusters and applied it to predict the cluster labels of fusion variants examined in this expanded targeted survey. We then categorized each fusion occurrence by the overall category of the hierarchical cluster to which the Leiden cluster label it was classified to belongs (e.g., “COSMIC-like” for C4 predictions) (Figure 6A and STAR Methods). Evaluation of this random forest classifier using 5-fold cross-validation and application to biological replicates demonstrates high prediction accuracy, with most clusters yielding >90% prediction accuracy and mispredicted fusion variants or biological replicate fusion variants assigned to fusion clusters with highly similar features, effectively discriminating artifact-like fusions from others (Figure S7). This fusion classification was further incorporated into FusionInspector for routine application in discriminating COSMIC-like fusions from artifacts or other types.
FusionInspector-screened occurrences of known COSMIC fusions were mostly tumor enriched with few to no normal samples identified with evidence (noting that all 1,009 GTEx normal samples were screened by FusionInspector for an identical list of COSMIC fusions). All but 31 of the 236 fusions had occurrences classified as C4. Only seven fusions had at least 10% of their occurrences predicted to clusters with high counter-evidence (C49 or C51), suggesting the fusion transcripts may reflect low levels of cis- or trans-splicing of more highly expressed normal fusion partner genes. Only nine fusions had any occurrences predicted as artifacts, found in both TCGA and GTEx as pancreas-specific fusions (further discussed below).
This analysis highlighted intriguing, well-supported fusions for further study. For example, while the top-ranked tumor-enriched fusion, FGFR3::TACC3 (rank 1, 70 tumor samples, 0 normal) is a known oncogenic driver,36 other top-ranking fusions, such as CCAT1:CASC8 (rank 2, 42 tumors—mostly lung and stomach cancers, 0 normal) and VCL::ADK (rank 3, 36 tumors—also mostly lung and stomach cancers, 0 normal) have not yet been extensively studied. CCAT1::CASC8 was only recently reported in the fusion catalog generated by DEEPEST fusion,17 and VCL::ADK was only previously reported in a study of cancer cell lines.12
Because our initial selection of samples for FusionInspector exploration of recurrent fusion transcripts did not strictly require COSMIC fusions, only 31 of the 58 known COSMIC fusions initially discovered by our comprehensive survey with STAR-Fusion were further characterized above. We thus further applied FusionInspector to 46 additional samples with instances of the remaining 27 COSMIC fusions. Over 80% of these COSMIC fusion occurrences were predicted to other COSMIC fusion-containing clusters, none as likely artifacts, and 11 (41%) of these had occurrences predicted to the COSMIC-enriched cluster C4 (Figure S8A and Table S5), including KLK2::ETV1, LMNA::NTRK1, RUNX1::RUNX1T1, FUS::DDIT3, TMPRSS2::ETV5, MYB::NFIB, TFG::NTRK1, TRIM27::RET, MKRN1::BRAF, INTS4::GAB2, and NUP214::ABL1.
Some fusion transcripts are prevalent in normal tissues and may not be oncogenic
Approximately one-third (86) of the 236 C4+ targeted fusions in our analysis were robustly detected in normal tissues (found in at least five normal samples); these may not be particularly relevant to cancer biology but may play a role in normal biological processes. Of these, 61 fusions are broadly expressed across at least five tissues, involve intrachromosomal pairs of genes, and can be largely explained by read-through transcription, local rearrangements, or trans-splicing of neighboring transcripts.
Some other putative fusions that are prevalent in normal tissues may in fact represent normal structural variation in the human genome, which is not accounted for when performing read alignment to a single human reference. For example, Fusion KANSL1::ARL17, which would require a local rearrangement in the human reference genome, is prevalent across both tumor and normal tissues (median of 31% of individuals, Figure S8B), and is known to correspond to a common haplotype involving a locally rearranged genomic region observed in populations of European descent.45 An earlier report identified KANSL1::ARL17 in diverse tumor samples and proposed that it may be a cancer predisposition germline fusion specific to Europeans.46 Note, however, that no specific human genetic association evidence was shown for predisposition thus far, and we observe slightly higher prevalence of KANSL::ARL17 among GTEx normal samples than in tumors from TCGA (Figure S8B). Another normal fusion due to a rarer germline structural variation is TFG::GPR128, previously associated with a copy number variation and a haplotype frequency estimated at around 2% of individuals of European descent.47 Consistently, we find TFG::GPR128 broadly expressed across tumor and normal tissues and represented similarly at a median of 2% of all tissues examined (Figure S8C). As more evidence of common structural variation becomes available, other prevalent fusions found in normal tissues may be more easily explained.
Another set of fusions that are less easily explained involve those we found only in normal pancreas and pancreatic carcinoma (Figures 6 and S6), involving various pairwise combination of CPA1, CPA2, CLPS, CELA2A, CELA3A, CTRB1, CTRB2, and CTRC (e.g., CELA3A::CPA2, CELA3B::CELA2A, and CELA3A::CELA2A) fused to generate in-frame fusion products. These genes are among the highest expressed in pancreas and mostly reside on different chromosomes, suggesting that trans-splicing may be the predominant underlying mechanism. While the initially detected transcripts were within the COSMIC-peak-enriched fusion cluster, the random-forest-based fusion classifier did not predict the additional instances as COSMIC-like, and some of them (e.g., CELA3A::CTRC) have high fractions of occurrences predicted to “high-counter-evidence” clusters or “artifact-like” types (Figures 6 and S6E; Table S4).
Some well-established oncogenic fusions are also reliably detected in normal samples
Several of the COSMIC fusions or other tumor-enriched fusions with known ties to cancer were surprisingly identified in both tumor and normal samples. For example, the prostate cancer fusion TMPRSS2::ERG, identified as our fourth most tumor-enriched fusion (182 of 465 TCGA prostate tumor samples), is also detected in six normal prostate samples (five TCGA and one GTEx) (Figure S6A). Each of the five TCGA prostate normal samples containing TMPRSS2::ERG were found with TMPRSS2::ERG in their matching prostate tumor samples, likely due to tumor-in-normal contamination. TMPRSS2::ERG was only identified by FusionInspector in prostate tumors or normal prostate, reflecting both this fusion’s high tissue specificity and FusionInspector’s high specificity of fusion calling.
In another example, COSMIC fusion PVT1:MYC was originally identified by STAR-Fusion in 20 samples (14 TCGA tumor, 1 TCGA normal, and 5 GTEx samples). Interactions between PVT1 and MYC including their fusion are well-known contributors to tumorigenesis.40,41,42 Through subsequent screening of PVT1::MYC with FusionInspector, we identify a total of 32 samples (+9 TCGA tumor, +1 TCGA normal, and +3, −1 GTEx). Most (21/32) are expressed at low levels (below 0.1 FFPM), and we do not find strong evidence for expression to be generally higher in tumor samples than in normals (p < 0.07, Wilcoxon rank-sum test). However, 5 of the 32 PVT1::MYC occurrences were identified in cervical cancer tumors, and all were significantly more highly expressed than the other samples (p < 0.001), with the most highly expressed at 19 FFPM (Figure S8D). PVT1 and MYC are co-localized to a proximal region in the bottom arm of chromosome 8, and a PVT1::MYC fusion would likely involve local restructuring at the locus in tumors to generate the fusion product. Interestingly, this chromosome 8 region is a known hotspot for insertion of human papilloma virus (HPV),48 the leading cause of cervical cancer (>90% of cases). Most of the TCGA cervical cancer samples we identified with PVT1::MYC have HPV insertions at this hotspot (see Table S3 of the study by TCGA Research Network48). Thus, we hypothesize that HPV insertion contributes to the formation of the PVT1::MYC fusions. We did not find evidence for HPV insertion in the breast cancer sample with similar levels of PVT1::MYC expression (data not shown).
COSMIC fusion VTI1A::TCF7L2, originally identified as an oncogenic fusion in colorectal cancer,49 was most abundant in stomach, colon, and esophageal carcinoma samples but was also detected in seven individual GTEx normal samples (brain, whole blood, tibial nerve, tibial artery, prostate, and breast) (Table S4). While VTI1A::TCF7L2 was not enriched for detection in tumors vs. normal, only those fusions in colon cancer were highly expressed (>0.15 FFPM), whereas other tumor and normal instances were lowly expressed (<0.05 FFPM; many at the limit of detection; Figure S8E), supported by a single split read defining the fusion breakpoint (Table S4). This could be consistent with a very low proportion of cells in the normal tissue expressing the fusion, compared with a large clone in the tumor.
Interestingly, COSMIC fusion BCR::ABL1 was not tumor enriched in our analysis, likely due to paucity of the relevant tumors in TCGA. In particular, BCR::ABL1 occurs in >95% of CML cases,1,2 but TCGA lacks CML samples. Indeed, the four TCGA tumors with BCR::ABL1 likely correspond to a subtype of AML defined with this fusion.50 Three of these AML tumors also have evidence of the reciprocal ABL1::BCR fusion, and the oncogenic BCR::ABL1 is expressed at higher levels than the reciprocal counterpart in each sample. Interestingly, we detected eight instances of the oncogenic BCR::ABL1 fusion (and none of the reciprocal) in six different GTEx normal tissues (one each of adipose, breast, nerve, prostate, and thyroid, and two pancreas) and one TCGA normal kidney sample. We observed no sequence or expression features distinguishing these fusions from those we identified in AML, and fusion transcript breakpoints for those in GTEx normal tissues are identical to those found in AML. In general, when we find COSMIC fusions in GTEx normal samples, they are found at low frequencies (<1% prevalence in a tissue type).
FusionInspector analysis of fusion transcripts in pediatric cancers
To highlight the utility of FusionInspector, we applied it to the 1,366 RNA-seq datasets from 1,230 participants across seven pediatric cancer projects in the Therapeutically Applicable Research to Generate Effective Treatments (TARGET) resource.51 These include acute lymphoblastic leukemia (ALL; 666 tumors), AML (217 tumors and 20 normal samples), clear cell sarcoma of the kidney (CCSK; 13 tumors), neuroblastoma (NB; 157 tumors), osteosarcoma (OS; 88 tumors), rhabdoid tumor (RT, 63 tumors and 6 normal), and Wilms’ tumor (WT; 130 tumors and 6 normal).
STAR-Fusion identified 213,786 fusion occurrences involving 108,661 distinct fusion gene pairs (Table S6) with 3 (RT) to 19 (CCSK) median fusions detected (minimum 0.1 FFPM) per tumor sample, and 2.5–3.5 median fusions per normal sample (similar to normal samples in TCGA or GTEx). Eighty-six percent of the STAR-Fusion predicted occurrences were in silico supported by FusionInspector, yielding 182,807 fusion occurrences with 217,614 fusion variants involving 88,307 distinct fusion gene pairs (Table S6), including 30 COSMIC fusion gene pairs. Some of the most prevalent included known pediatric cancer fusions RUNX1::RUNX1T1 (15% AML participants), KMT2A::MLLT3/MLLT10 (12% AML), TCF3::PBX1 (4.4% ALL), and ETV6::RUNX1 (2.4% ALL). Of these 30 TARGET COSMIC fusions, 22 were only found among the TARGET pediatric tumors with the remaining eight also found among TCGA samples (Figure S9A–S9C).
The random forest classifier classified 1.6% of the 217,614 fusion variants as COSMIC-like and 1.2% as artifact-like. The fusion variants partitioned into 79 clusters, one of which (C21TARGET), containing 3,091 occurrences of 910 fusions, was significantly enriched for COSMIC fusions (p < 10−150, one-sided Fisher’s exact test) (Figures 7A and S9D), including 22 of the 30 COSMIC fusions. These included hallmark fusions RUNX1::RUNX1T1, TCF3::PBX1, ETV6::RUNX1, and several KTM2A-partnered fusions. Some samples had evidence of reciprocal fusion partners, including BCR::ABL1 and ABL1::BCR (Figure 7B). The fusions in C21TARGET had sequence and expression features consistent with the COSMIC-enriched cluster C4 of TCGA and GTEx fusions, especially high fusion expression, and 3′-FAR generally exceeding 5′-FAR (Figure 7A).
We examined C21TARGET fusions to identify other fusions potentially relevant to pediatric cancer. Of 910 fusions, 108 recurrent fusion candidates were present in at least three samples and absent from normal samples (Figure 7B and Table S6). These include fusions not yet reported in the COSMIC oncogenic fusion database but otherwise known as drivers or highly relevant to pediatric oncology,51,52 such as TCF3::HLF,53,54,55 ZNF384::EP300,56 and CBFB::MYH11.57 Many of the 108 fusions (51 fusions = 47%) involve a known ALL driver as one or both partners,52 such as KMT2A (eight fusions); PAX5, ZNF384, and MLLT10 (five fusions each); and NUP98, TCF3, and ETV6 (four fusions each). Most driver-gene-containing fusions (28/51 = 55%) involve reciprocal fusion arrangements. Other fusion partners frequently found among this set that may be potentially relevant to pediatric cancer include PTMA (seven fusions), EIF4A1 and the EIF4A1 locus-derived RP11-186B7.4 (seven unique fusions), and SEPT14 (three fusions).
While our version of FusionInspector was not compatible with exploration of immunoglobulin heavy chain gene (IGH) fusions given the large IGH locus size (1.3 Mb vs. our 100 kb maximum intron length; STAR Methods), 12 (1.8%) TARGET ALL samples had evidence of IGH::CRLF2 fusions, a common oncogenic IGH fusion.58 We also found the oncogenic ALL fusion P2RY8::CRLF259 in 25 (3.8%) ALL participants. These were members of C10TARGET, likely due to consensus splice breakpoints that did not coincide with reference gene structure exon boundaries, highlighting the relevance of other clusters as sources of biologically relevant fusions with alternative non-artifactual attribute profiles.
Discussion
We developed FusionInspector to enable exploration of the evidence supporting candidate fusions, flag likely artifacts, and identify those fusions with sequence and expression features similar to known biologically relevant fusion transcripts irrespective of oncogenicity or potential genome structural rearrangements. Given a list of candidate fusions, FusionInspector captures RNA-seq read alignments that support either the fused genes or the unfused partner genes. From the fusion and partner gene expression evidence coupled with sequence features relating to the fusion breakpoint, FusionInspector helps the user to reason about the nature and quality of any target fusion transcript.
Clustering TCGA and GTEx fusions by shared sequence and expression features identified a cluster of fusions highly enriched for COSMIC fusions. Fusions in the COSMIC-enriched cluster had relatively high fusion expression with 3′-FAR generally exceeding 5′-FAR, suggesting oncogenic activity from the 3′-fused transcript. Analysis initiated by fusions in the COSMIC-enriched cluster highlighted several putative or less appreciated oncogenic fusions, including CCAT1::CASC8 and VCL::ADK, based on their feature similarity to other well-known tumor-enriched fusions. Only ∼3% of initially predicted fusions were members of clusters likely enriched for artifacts based on features such as high partner gene expression or sites of microhomology at or near the fusion breakpoint. The low artifact rate is likely due to the strong filtering of the initial input catalog from STAR-Fusion.
We obtained similar results when applying FusionInspector to the TARGET pediatric cancer cohorts, with a single COSMIC-enriched cluster of fusion occurrences with relatively high fusion expression and 3′-FAR, containing known cancer drivers and yielding a source of additional potential fusion genes for future study. These additional fusions included gene partners PTMA, EIF4A1, and SEPT14, each with known roles in cancer (e.g., Frattini et al.,39,60,61 Kumar et al.,39,60,61 and Wu et al.39,60,61) but yet to be further characterized as pediatric cancer fusion transcripts.
While we focused on fusions identified in COSMIC-enriched clusters, other fusion clusters also harbor important oncogenic fusions. For example, the COSMIC fusions SS18::SSX1 and SS18::SSX2, known drivers of synovial sarcoma,5,62 are in other clusters (C38 and C39), due in part to their higher 5′-FAR. Another fusion of interest, FSIP1::RP11-624L4.1, is present in 240 (22%) of breast tumors analyzed and in 16 normal breast tissues samples, where it is expressed at significantly lower levels in normal tissues (Figure S10). While the individual fusion partners have cancer associations,63,64 any role for this likely read-through/cis-spliced fusion transcript deserves consideration in further exploring the roles of both genes in disease.
In some cases, fusions that were found in both tumor and normal tissues might reflect a low level of oncogenic events. For example, hallmark driver fusions including TMPRSS2::ERG and BCR::ABL1 were also detected in GTEx normal tissue samples, which may reflect a low proportion of premalignant or transformed cells.65,66,67 We also detected COSMIC fusion VTI1A::TCF7L2 across multiple tumor and normal tissue types (consistent with Nome et al.68), but only highly expressed in colon cancer samples where it is a postulated oncogenic driver.49,69 Whether such a fusion could contribute to tumorigenesis in a different tissue with different cellular circuitry remains unknown. While we are intrigued by evidence of oncogenic fusions in normal tissue RNA-seq data, we have not ruled out explanations such as tumor-in-normal contamination70 or potential cross-sample sequencing read contamination.71
Fusions that were prevalent among normal tissues can mostly be explained by read-through transcription and cis-splicing of co-linear genes, but some may simply reflect natural germline structural variations that may exist in the population. With ongoing advancements in methods for detecting and cataloging of structural variants,72,73 we may soon better understand the structural basis for many naturally occurring fusion transcripts. Access to matched RNA-seq and WGS of the same samples across individuals would greatly facilitate such efforts.
Pancreas stood out as a clear outlier among all normal tissues explored for fusions. While we suspect some of the putative fusions detected in pancreas are derived from reverse transcription or alignment artifacts, several did have features consistent with trans-splicing of highly expressed partner genes, with trans-spliced products yielding in-frame proteins. In general, these fusion occurrences do not have COSMIC-like sequence and expression features. Trans-spliced in-frame fusion transcripts have the potential to expand functional diversity from our otherwise linear genomes,74 and even if these pancreas-specific candidates failed to ultimately reach our COSMIC-like prioritization status, they may be worth additional studies.
FusionInspector opens the way to further explore the biological impact of the predicted fusions and the tissues and gene expression networks in which they are phenotypically relevant. FusionInspector helps illuminate the evidence supporting fusions in RNA-seq or to screen for relevant fusions sensitively and accurately in samples of interest. While expression attribute analysis and fusion class prediction by FusionInspector should require poly(A)-stranded RNA-seq, the supervised fusion variant identification could leverage alternative RNA-seq methodologies.
Because short reads remain limited in their capacity to represent full-length fusion transcripts, FusionInspector further integrates Trinity75,76 for de novo reconstruction to optionally reconstruct more full-length fusion transcripts from RNA-seq data aligned to each fusion contig. FusionInspector is available as a stand-alone application for screening lists of candidate fusion transcripts and is also incorporated into STAR-Fusion for in silico validation or visualization of STAR-Fusion-predicted fusion transcripts. This facilitates analysis of fusions from both bulk and single-cell RNA-seq, as we have recently demonstrated.77
Long-read transcriptome sequencing may eventually obviate short-read sequencing for fusion detection, thus removing the need for de novo reconstruction of full-length fusion transcripts.78,79 Full-length single-molecule direct RNA-seq80 should also avoid reverse transcription amplification artifacts. Conversely, other features scored by FusionInspector, such as expression characteristics of fusion transcripts with respect to partner genes, will remain relevant and easily adapted for long-read RNA-seq.
Machine learning is likely to play an increasingly important role in biomedical science and its clinical applications. In this paper we emphasize an important companion direction to machine learning, namely generating transparent and interpretable predictions, loosely referred to as explanations. The area of explanations and causal interpretation is growing rapidly in artificial intelligence.81 We need to keep a reproducible trace of facts, predictions, and hypotheses from gene to function in the era of big data.
We hope that the practical applicability of FusionInspector will help drive transparency and other explanatory efforts in predictive areas in genomics and personalized medicine more generally, including screening and reassessment of evidence supporting fusion predictions, and visualization of the evidence via interactive reports (Figures 1 and S1B). FusionInspector can be easily leveraged as an add-on component to any fusion transcript prediction pipeline, and is directly incorporated into STAR-Fusion to facilitate execution as part of the Trinity Cancer Transcriptome Analysis toolkit.82 The FusionInspector software is freely available as open source on GitHub (key resources table), provided in container form via Docker and Singularity, and accessible on the Terra cloud computing framework for secure and scalable application across large compendia of sample collections or patient-derived RNA-seq data.
Limitations of the study
FusionInspector as implemented here requires read alignment overlap with exons of reference gene structure annotations, and hence fusions restricted to intronic regions of either fusion partner or neighboring intergenic regions presently go undetected. Because genome-level fusion events often occur outside of exons, FusionInspector is largely ineffective with whole-genome or whole-exome sequencing data, instead necessitating RNA-seq.
STAR★Methods
Key resources table
REAGENT or RESOURCE | SOURCE | IDENTIFIER |
---|---|---|
Deposited data | ||
TCGA RNA-seq | http://Terra.bio | dbGaP: phs000854 |
Breast cancer cell lines RNA-seq for BT474, KPL4, MCF7, and SKBR3 | SRA | SRA:SRP003186 |
GTEx RNA-seq | http://Terra.bio | dbGaP: phs000424 |
TARGET RNA-seq | http://Terra.bio | dbGaP: Acute Lymphoblastic Leukemia: phs000463, phs000464; Acute Myeloid Leukemia (AML): phs000465; Clear Cell Sarcoma of the Kidney (CCSK): phs000466; Neuroblastoma (NB): phs000467; Osteosarcoma (OS): phs000468; Rhabdoid Tumor (RT): phs000470; Wilms Tumor (WT): phs000471 |
Software and algorithms | ||
FusionInspector v2.4.0 | This paper | https://github.com/FusionInspector/FusionInspector/releases/tag/FusionInspector-v2.4.0 or https://doi.org/10.5281/zenodo.7791682 |
STAR-Fusion v1.7 | GitHub | https://github.com/STAR-Fusion/STAR-Fusion/releases/tag/v1.7.0 |
STAR-Fusion v1.9.1 | GitHub | https://github.com/STAR-Fusion/STAR-Fusion/releases/tag/v1.9.1 |
Other | ||
Supplementary code | This paper | https://github.com/broadinstitute/FusionInspectorPaper or https://doi.org/10.5281/zenodo.7791682 |
Resource availability
Lead contact
Further information and requests for resources or code should be directed to lead contact Brian Haas (bhaas@broadinstitute.org).
Materials availability
This study did not generate new unique reagents.
Method details
Initial comprehensive fusion transcript survey for TCGA and GTEx via STAR-Fusion
Fusions were predicted for TCGA and GTEx samples using STAR-Fusion (v1.7). First, the STAR (v2.6.1a) aligner was used to align RNA-seq reads from each sample to the human genome as follows:
"STAR --genomeDir ctat_genome_lib_build_dir/ref_genome.fa.star.idx --outReadsUnmapped None --chimSegmentMin 12 --chimJunctionOverhangMin 12 --chimOutJunctionFormat 1 --alignSJDBoverhangMin 10 --alignMatesGapMax 100000 --alignIntronMax 100000 --alignSJstitchMismatchNmax 5 -1 5 5 --runThreadN 16 --outSAMstrandField intronMotif --outSAMunmapped Within --outSAMtype BAM Unsorted --readFilesIn reads_1.fastq reqds_2.fastq --outSAMattrRGline ID:GRPundef --chimMultimapScoreRange 10 --chimMultimapNmax 10 --chimNonchimScoreDropMin 10 --peOverlapNbasesMin 12 --peOverlapMMp 0.1 --genomeLoad NoSharedMemory --twopassMode Basic.
The resulting Chimeric.out.junction files generated by STAR containing candidate chimeric reads were then analyzed by STAR-Fusion like so "STAR-Fusion -J Chimeric.out.junction -O $output_dir/STARF --genome_lib_dir $ctat_genome_lib --min_FFPM 0 --no_annotation_filter" leveraging CTAT genome library GRCh38_gencode_v22_CTAT_lib_Sept032019.
The parameters used here eliminated any filtering of fusions according to fusion expression levels or based on fusion annotations, to retain any fusions known to frequently occur in normal samples in both the normal and the tumor samples for further study. All STAR-Fusion predictions are provided in Table S2.
Fusion tumor enrichment was computed for each fusion according to ( (# tumor with fusion + 1) / (total tumor samples)) / ( (# normal with fusion + 1) / (total normal samples) ).
FusionInspector method and implementation
FusionInspector takes as input a list of candidate fusions and RNA-seq files in fastq format, with each fusion formatted as "geneA::geneB" indicating a candidate fusion between geneA (5’) and geneB (3). Leveraging the companion CTAT genome library set of genomic resources (identical to that used with STAR-Fusion, including the human reference genome, gene structure annotations, and STAR genome index), FusionInspector constructs fusion contigs by extracting the genomic sequences for each geneA and geneB, and concatenating each geneA and geneB pair into a single contig in collinear transcribed orientation. Gene structure annotations for fusion genes are similarly restructured to match the position and orientation of the corresponding genes in the fusion contigs. By default, long introns are shrunk to 1 kb in length by removing central regions of intron sequences, reducing the alignment search space and simplifying downstream visualizations.
RNA-seq reads are aligned to the fusion contigs along with the whole reference genome by running STAR with both inputs, including the pre-indexed whole genome and a fasta file containing the fusion contigs. STAR first loads the whole reference genome index into RAM, then builds an index for the fusion contigs, and incorporates the fusion contig index into the whole genome index. Only those reads that align concordantly to the fusion contigs, while considering all alignments to the combined targets, are reported. Note, that in the fusion context, all fusion-supporting reads are aligned concordantly, but will align partially to one gene and partially to the adjacent gene. This functionality was implemented in STAR since version 2.5.0a to support FusionInspector functionality. STAR-Fusion directly executes STAR to align reads like so " STAR --runThreadN 4 --genomeDir ctat_genome_lib_build_dir/ref_genome.fa.star.idx --outSAMtype BAM SortedByCoordinate --twopassMode Basic --alignSJDBoverhangMin 10 --genomeSuffixLengthMax 10000 --limitBAMsortRAM 47271261705 --alignInsertionFlush Right --alignMatesGapMax 100000 --alignIntronMax 100000 --readFilesIn reads_1.fastq.gz reads_2.fastq.gz --genomeFastaFiles finspector.fa --outSAMfilter KeepAllAddedReferences --sjdbGTFfile finspector.gtf --alignSJstitchMismatchNmax 5 -1 5 5 --scoreGapNoncan −6 --readFilesCommand 'gunzip -c' ", where 'finspector.fa' and 'finspector.gtf' correspond to the fusion contigs sequence and structure annotation files.
FusionInspector examines the aligned reads output by STAR and identifies read alignments supporting fusions between gene pairs represented by the fusion contigs. Candidate fusion breakpoints are identified by split read alignments having partial alignments that anchor to exons of the neighboring fusion genes. Spanning fragments are identified as paired-end reads having each read mapping entirely on opposite sides of the breakpoint. Alignments must meet minimum criteria to be counted as evidence, requiring at least 98% sequence identity and no more than 10 bases unaligned at their ends (soft- or hard-clipped bases). For split reads, at least 10 bases must align adjacent to each breakpoint (anchor), and each anchor region must have sufficient sequence complexity, requiring entropy ≥ 1.2. For spanning fragments, each paired-end read sequence must have sufficient complexity, requiring entropy ≥ 1.2. Preliminary fusion predictions are defined based on candidate fusion breakpoints and sets of compatible spanning fragments. RNA-seq fragments that span a candidate breakpoint but support transcription from an unfused partner gene are captured, stored as counter-evidence, and used to compute the partner gene counter FFPM and fusion allelic ratio.
There is often evidence for multiple fusion variants, and while the split reads are unique to and define each breakpoint, the spanning fragments are often compatible with multiple breakpoints and assigned ambiguously. We implemented an expectation maximization (EM) algorithm based on that described in kallisto83 to fractionally assign RNA-seq evidence fragments to fusion variants according to maximum likelihood. Fusion expression values (FFPM) are then computed based on estimated RNA-seq fragment counts resulting from the EM.
Fusion candidates are then filtered according to defined minimum evidence requirement, with defaults set as requiring at least one split read to define the junction breakpoint, and at least 25 aligned bases supported by at least one read on both sides of the fusion breakpoint (termed ‘long double anchor support’ or ‘LDAS’). If the breakpoint involves non-consensus dinucleotide splice sites, then at least three split reads are required to support the breakpoint. A final filter of fusion predictions to exclude those containing overly promiscuous fusion partners (maximum 10) or those involving paralogs of more dominantly supported fusions is applied identically as previously described.84
Optionally, Trinity de novo assembly75,76 is integrated to de novo reconstruct candidate fusion transcripts based on reads aligning to the fusion contigs. When employed, Trinity-reconstructed fusion transcripts are identified in the final FusionInspector report, and the assembled transcripts are available for further study. In addition, FusionInspector integrates IGV-reports85 to generate an interactive web-based summary (and fully self-contained html file) of predicted fusions coupled to a web-based interactive genome viewer to examine the read alignments found as evidence for the fusions (Figure S1B).
Applications of FusionInspector to TCGA, GTEx, TARGET, and cell lines
FusionInspector was run on TCGA v11, GTEx v8, and TARGET via Terra/AnVIL,86 as outlined in our analysis roadmap (Figure S1A). First, FusionInspector v2.4.0 was used to reexamine a subset of 628 TCGA and 530 GTEx samples identified as containing instances of recurrent STAR-Fusion (v1.7) predictions. Candidate samples were identified based on individual fusions (a) having minimum 0.1 FFPM, (b) found in tissue types with at least three occurrences, and either (c) comprising at least 10% of samples of that tissue type, or (d) containing a recurrent COSMIC fusion (ie. (a & b) & (c |d)). Samples were then greedily selected to maximize recurrent fusion content while minimizing numbers of selected samples, retaining up to 10 samples per fusion. These samples and all fusions predicted among these samples (not restricted to those recurrent fusions leveraged as sample selection criteria) were reexamined by executing the current STAR-Fusion (v1.9.1) including FusionInspector (v2.4.0) as a post-process like so: "STAR-Fusion --left_fq ${sample_name}_1.fastq --right_fq ${sample_name}_2.fastq --CPU 16 --genome_lib_dir ctat_genome_lib_build_dir --output_dir ${sample_name} --FusionInspector validate --no_annotation_filter --min_FFPM 0.0 ″ leveraging companion CTAT genome library "GRCh38_gencode_v22_CTAT_lib_Apr032020". The FusionInspector abridged outputs were consolidated and presented as Table S3. These fusions were subsequently subject to Leiden clustering87 (see Fusion Clustering and Class Prediction section below).
Second, FusionInspector was run in fusion screening mode to explore instances of defined COSMIC-peak-enriched fusions (Leiden cluster 4 (C4) of the 61 fusion clusters found to be heavily enriched for COSMIC fusions). There were 231 instances of C4 fusions selected according to the following criteria: found in at least 3 samples, at least one fusion occurrence found clustered to C4, and at least 30% of occurrences found localized to clusters containing at least two known COSMIC fusion occurrences. These were further supplemented with five recurrent COSMIC fusions that are not members of C4 (ERC1::RET, SLC34A2::ROS1, SS18::SSX1, SS18::SSX2, and VTI1A::TCF7L2), to a total of 236 fusion gene pairs (Table S4). The 236 fusion gene targets were provided as input to FusionInspector for screening 2,764 TCGA and 1,009 GTEx samples, each with the same list of 236 candidates. These samples were selected based on having a STAR-Fusion predicted occurrence of at least one of these fusions (from Table S2) and selecting a maximum of 50 samples per-fusion gene-pairing (with samples sometimes containing multiple fusion types), except for pancreatic and prostate cancer (TCGA) and normal pancreas tissue (GTEx) for which all samples were selected as targets. FusionInspector was executed like so: "FusionInspector --fusions $Table_S4_fusions --genome_lib_dir ctat_genome_lib_build_dir -O ${sample_name} --left_fq ${sample_name}_1.fastq --right_fq ${sample_name}_2.fastq --out_prefix ${sample_name} --vis" leveraging companion CTAT genome library "GRCh38_gencode_v22_CTAT_lib_Apr032020", and results for screening of these samples are provided in Table S5. TARGET RNA-seq samples were processed as above first leveraging STAR-Fusion-v1.10.0 for initial fusion candidate identification followed by FusionInspector-v2.4.0 for in silico fusion validation.
Using RNA-seq data for breast cancer cell lines BT474, MCF7, KPL4, and SKBR3 as in,11 FusionInspector-v2.4.0 was run on each sample with a targeted list of 52 experimentally validated fusions (Table S1).
Fusion transcript clustering and attribute class prediction
All 53,240 fusion variants surveyed by FusionInspector from our initial subset of TCGA and GTEx samples were clustered according to sequence and expression characteristics. Microhomologies defined as exact k-mers with k = 10 were identified between candidate fusion gene pairs as represented in the FusionInspector-constructed fusion contigs (with introns shrunk to a max of 1 kb each for simpler visualizations). The Euclidean distance of each candidate fusion breakpoint to the nearest site of microhomology was determined in the FusionInspector fusion contig coordinate system. Attributes of interest for clustering fusions were: (1) the fusion expression level (FFPM), (2,3) partner gene fusion allelic ratios (5′-FAR and 3′-FAR), (4,5) the left and right unfused partner gene expression levels expressed as 5′- and 3'-counter-FFPM and computed based on the number of counter-reads observed as aligned at each corresponding gene breakpoint site, (6,7) indicators for consensus dinucleotides and agreement with reference gene structure exon boundaries at the fusion breakpoints, and (8) the number of microhomologies and (9) distance of the breakpoint to the nearest microhomology. These numerical values were centered and scaled to Z-scores, truncated within the interval [-2,2] to remove outliers, and then rescaled so each attribute numerical vector would fill the interval [-2,2] simplifying our evaluation of metrics using a consistent low-to-high range for each attribute type.
We calculated the distance between fusions based on vectors with these values, constructed a k-nearest-neighbor graph (k=50) of fusions, and clustered the graph by Leiden clustering87 (resolution parameters set as 3 for TCGA & GTEx, and 2 for TARGET). The impact of the resolution parameter on clustering and COSMIC fusion enrichment was examined (Figure S4), and the parameter with sufficiently granular set of clusters was selected for further analysis. Clusters were manually reviewed and grouped and annotated according to median cluster attributes, with cluster annotation term assignments as "COSMIC-like" if predicted as cluster C4, and categories "High FAR" and "Microhomology RT-induced artifact" to reflect likely bioinformatic or reverse-transcription related artifacts (as labeled in Figure 5B).
A random forest classifier was built to predict Leiden cluster membership based on each fusion variant’s scaled feature attributes. The classifier was constructed by randomly selecting a maximum of 300 fusions (median cluster size) from each cluster, and leveraging 2/3 of fusions for training and 1/3 for testing, all performed using Ranger.88 Fusions predicted to be assigned to any cluster noted earlier with a fusion cluster annotation (e.g., "COSMIC-like") are assigned a prediction according to that fusion cluster annotation term. Such fusion attribute cluster predictions are now incorporated into FusionInspector (v2.8.0).
Quantification and statistical analysis
Statistical tests were performed using R as indicated, with P-values adjusted by Benjamini-Hochberg procedure to control the false discovery rate. Wilcoxon rank-sum test was restricted to comparisons involving at least three members of each set. All statistical analyses performed are included within the Supplementary Code (key resources table).
Acknowledgments
We thank Joshua Gould for assisting with software pipeline development and Terra integration, and Leslie Gaffney for help with generating publication quality figures. Special thanks to Jinghui Zhang at St. Jude for insights and assistance in navigating the TARGET data. This work has been supported by National Cancer Institute grants U24CA180922 (A.R. and B.J.H.), R50CA211461 (B.J.H.), Howard Hughes Medical Institute (A.R.), Klarman Cell Observatory (A.R.), NHGRI R01HG009318 (A.D.), and American Association of Obstetricians and Gynecologists Foundation scholar grant 2017-2020 (A.V.A.). The results published here are in whole or part based upon data generated by the TCGA Research Network: https://www.cancer.gov/ccg/research/genome-sequencing/tcga. TCGA v11 data were obtained through Terra/AnVIL via dbGaP accession number phs000178.v11.p8. The Geno-type-Tissue Expression (GTEx) Project was supported by the Common Fund of the Office of the Director of the National Institutes of Health, and by NCI, NHGRI, NHLBI, NIDA, NIMH, and NINDS. The GTEx v8 data used for the analyses described in this paper were obtained from Terra/AnVIL via dbGaP accession number phs000424.v8.p2. The results published here are in whole or part based upon data generated by the Therapeutically Applicable Research to Generate Effective Treatments (https://www.cancer.gov/ccg/research/genome-sequencing/target) initiative, phs000218. The data used for this analysis are available at https://portal.gdc.cancer.gov/projects.
Author contributions
B.J.H. performed analyses, developed the FusionInspector software, and wrote the initial draft of the manuscript. A.D. enhanced the STAR aligner software to support FusionInspector execution. J.T.R. and T.T. developed the FusionInspector IGV-reports interactive fusion evidence visualization component. A.V.A. assisted with investigations of HPV insertions and MYC::PVT1 fusion studies in CESC samples. A.R. and S.K. advised this work. All authors made intellectual contributions toward the design of FusionInspector and to the final manuscript.
Declaration of interests
A.R. is a co-founder and equity holder of Celsius Therapeutics, an equity holder in Immunitas, and was a scientific advisory board member of Thermo Fisher Scientific, Syros Pharmaceuticals, Neogene Therapeutics, and Asimov until July 31, 2020. From August 1, 2020, A.R. has been an employee of Genentech. M.G. is a current employee and stockholder at Monte Rosa Therapeutics.
Published: May 8, 2023
Footnotes
Supplemental information can be found online at https://doi.org/10.1016/j.crmeth.2023.100467.
Supplemental information
Data and code availability
-
•
This paper analyzes existing, publicly available data. These accession numbers for the datasets are listed in the key resources table.
-
•
All original code has been deposited at GitHub and Zenodo and is publicly available as of the date of publication. URLs and DOIs are listed in the key resources table.
-
•
Any additional information required to reanalyze the data reported in this paper is available from the lead contact upon request.
References
- 1.Kurzrock R., Gutterman J.U., Talpaz M. The molecular genetics of Philadelphia chromosome-positive leukemias. N. Engl. J. Med. 1988;319:990–998. doi: 10.1056/NEJM198810133191506. [DOI] [PubMed] [Google Scholar]
- 2.Ren R. Mechanisms of BCR-ABL in the pathogenesis of chronic myelogenous leukaemia. Nat. Rev. Cancer. 2005;5:172–183. doi: 10.1038/nrc1567. [DOI] [PubMed] [Google Scholar]
- 3.Tomlins S.A., Rhodes D.R., Perner S., Dhanasekaran S.M., Mehra R., Sun X.W., Varambally S., Cao X., Tchinda J., Kuefer R., et al. Recurrent fusion of TMPRSS2 and ETS transcription factor genes in prostate cancer. Science. 2005;310:644–648. doi: 10.1126/science.1117679. [DOI] [PubMed] [Google Scholar]
- 4.Rubin M.A., Maher C.A., Chinnaiyan A.M. Common gene rearrangements in prostate cancer. J. Clin. Oncol. 2011;29:3659–3668. doi: 10.1200/JCO.2011.35.1916. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 5.Clark J., Rocques P.J., Crew A.J., Gill S., Shipley J., Chan A.M., Gusterson B.A., Cooper C.S. Identification of novel genes, SYT and SSX, involved in the t(X;18)(p11.2;q11.2) translocation found in human synovial sarcoma. Nat. Genet. 1994;7:502–508. doi: 10.1038/ng0894-502. [DOI] [PubMed] [Google Scholar]
- 6.Hale R., Sandakly S., Shipley J., Walters Z. Epigenetic targets in synovial sarcoma: a mini-review. Front. Oncol. 2019;9:1078. doi: 10.3389/fonc.2019.01078. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 7.Yang W., Lee K.W., Srivastava R.M., Kuo F., Krishna C., Chowell D., Makarov V., Hoen D., Dalin M.G., Wexler L., et al. Immunogenic neoantigens derived from gene fusions stimulate T cell responses. Nat. Med. 2019;25:767–775. doi: 10.1038/s41591-019-0434-2. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 8.Wei Z., Zhou C., Zhang Z., Guan M., Zhang C., Liu Z., Liu Q. The landscape of tumor fusion neoantigens: a pan-cancer analysis. iScience. 2019;21:249–260. doi: 10.1016/j.isci.2019.10.028. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 9.Wang Q., Xia J., Jia P., Pao W., Zhao Z. Application of next generation sequencing to human gene fusion detection: computational tools, features and perspectives. Briefings Bioinf. 2013;14:506–519. doi: 10.1093/bib/bbs044. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 10.Kumar S., Razzaq S.K., Vo A.D., Gautam M., Li H. Identifying fusion transcripts using next generation sequencing. Wiley Interdiscip. Rev. RNA. 2016;7:811–823. doi: 10.1002/wrna.1382. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 11.Haas B.J., Dobin A., Li B., Stransky N., Pochet N., Regev A. Accuracy assessment of fusion transcript detection via read-mapping and de novo fusion transcript assembly-based methods. Genome Biol. 2019;20:213. doi: 10.1186/s13059-019-1842-9. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 12.Klijn C., Durinck S., Stawiski E.W., Haverty P.M., Jiang Z., Liu H., Degenhardt J., Mayba O., Gnad F., Liu J., et al. A comprehensive transcriptional portrait of human cancer cell lines. Nat. Biotechnol. 2015;33:306–312. doi: 10.1038/nbt.3080. [DOI] [PubMed] [Google Scholar]
- 13.Babiceanu M., Qin F., Xie Z., Jia Y., Lopez K., Janus N., Facemire L., Kumar S., Pang Y., Qi Y., et al. Recurrent chimeric fusion RNAs in non-cancer tissues and cells. Nucleic Acids Res. 2016;44:2859–2872. doi: 10.1093/nar/gkw032. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 14.Hu X., Wang Q., Tang M., Barthel F., Amin S., Yoshihara K., Lang F.M., Martinez-Ledesma E., Lee S.H., Zheng S., Verhaak R.G.W. TumorFusions: an integrative resource for cancer-associated transcript fusions. Nucleic Acids Res. 2018;46:D1144–D1149. doi: 10.1093/nar/gkx1018. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 15.Yoshihara K., Wang Q., Torres-Garcia W., Zheng S., Vegesna R., Kim H., Verhaak R.G.W. The landscape and therapeutic relevance of cancer-associated transcript fusions. Oncogene. 2015;34:4845–4854. doi: 10.1038/onc.2014.406. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 16.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:D81–D85. doi: 10.1093/nar/gkp982. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 17.Dehghannasiri R., Freeman D.E., Jordanski M., Hsieh G.L., Damljanovic A., Lehnert E., Salzman J. Improved detection of gene fusions by applying statistical methods reveals oncogenic RNA cancer drivers. Proc. Natl. Acad. Sci. USA. 2019;116:15524–15533. doi: 10.1073/pnas.1900391116. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 18.Carrara M., Beccuti M., Lazzarato F., Cavallo F., Cordero F., Donatelli S., Calogero R.A. State-of-the-art fusion-finder algorithms sensitivity and specificity. BioMed Res. Int. 2013;2013 doi: 10.1155/2013/340620. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 19.Kumar S., Vo A.D., Qin F., Li H. Comparative assessment of methods for the fusion transcripts detection from RNA-Seq data. Sci. Rep. 2016;6 doi: 10.1038/srep21597. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 20.Yu C.Y., Liu H.J., Hung L.Y., Kuo H.C., Chuang T.J. Is an observed non-co-linear RNA product spliced in trans, in cis or just in vitro? Nucleic Acids Res. 2014;42:9410–9423. doi: 10.1093/nar/gku643. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 21.Schmidt B.M., Davidson N.M., Hawkins A.D.K., Bartolo R., Majewski I.J., Ekert P.G., Oshlack A. Clinker: visualizing fusion genes detected in RNA-seq data. GigaScience. 2018;7 doi: 10.1093/gigascience/giy079. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 22.Schmidt B., Cmero M., Ekert P., Davidson N., Oshlack A. Slinker: visualising novel splicing events in RNA-Seq data. F1000Res. 2021;10:1255. doi: 10.12688/f1000research.74836.1. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 23.Lågstad S., Zhao S., Hoff A.M., Johannessen B., Lingjærde O.C., Skotheim R.I. chimeraviz: a tool for visualizing chimeric RNA. Bioinformatics. 2017;33:2954–2956. doi: 10.1093/bioinformatics/btx329. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 24.Kim P., Yiya K., Zhou X. FGviewer: an online visualization tool for functional features of human fusion genes. Nucleic Acids Res. 2020;48:W313–W320. doi: 10.1093/nar/gkaa364. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 25.Zhang J., Gao T., Maher C.A. INTEGRATE-Vis: a tool for comprehensive gene fusion visualization. Sci. Rep. 2017;7 doi: 10.1038/s41598-017-18257-2. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 26.Peng Z., Yuan C., Zellmer L., Liu S., Xu N., Liao D.J. Hypothesis: artifacts, including spurious chimeric RNAs with a short homologous sequence, caused by consecutive reverse transcriptions and endogenous random primers. J. Cancer. 2015;6:555–567. doi: 10.7150/jca.11997. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 27.Shivram H., Iyer V.R. Identification and removal of sequencing artifacts produced by mispriming during reverse transcription in multiple RNA-seq technologies. RNA. 2018;24:1266–1274. doi: 10.1261/rna.066217.118. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 28.Dobin A., Davis C.A., Schlesinger F., Drenkow J., Zaleski C., Jha S., Batut P., Chaisson M., Gingeras T.R. STAR: ultrafast universal RNA-seq aligner. Bioinformatics. 2013;29:15–21. doi: 10.1093/bioinformatics/bts635. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 29.Bruford E.A., Antonescu C.R., Carroll A.J., Chinnaiyan A., Cree I.A., Cross N.C.P., Dalgleish R., Gale R.P., Harrison C.J., Hastings R.J., et al. HUGO Gene Nomenclature Committee (HGNC) recommendations for the designation of gene fusions. Leukemia. 2021;35:3040–3043. doi: 10.1038/s41375-021-01436-6. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 30.Soda M., Choi Y.L., Enomoto M., Takada S., Yamashita Y., Ishikawa S., Fujiwara S.i., Watanabe H., Kurashina K., Hatanaka H., et al. Identification of the transforming EML4-ALK fusion gene in non-small-cell lung cancer. Nature. 2007;448:561–566. doi: 10.1038/nature05945. [DOI] [PubMed] [Google Scholar]
- 31.Sabir S.R., Yeoh S., Jackson G., Bayliss R. EML4-ALK variants: biological and molecular properties, and the implications for patients. Cancers. 2017;9 doi: 10.3390/cancers9090118. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 32.Cancer Genome Atlas Research Network. Weinstein J.N., Collisson E.A., Mills G.B., Shaw K.R.M., Ozenberger B.A., Ellrott K., Shmulevich I., Sander C., Stuart J.M. The cancer genome atlas pan-cancer analysis project. Nat. Genet. 2013;45:1113–1120. doi: 10.1038/ng.2764. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 33.GTEx Consortium The genotype-tissue expression (GTEx) project. Nat. Genet. 2013;45:580–585. doi: 10.1038/ng.2653. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 34.Forbes S.A., Beare D., Boutselakis H., Bamford S., Bindal N., Tate J., Cole C.G., Ward S., Dawson E., Ponting L., et al. COSMIC: somatic cancer genetics at high-resolution. Nucleic Acids Res. 2017;45:D777–D783. doi: 10.1093/nar/gkw1121. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 35.Wellcome Sanger Institute . 2019. COSMIC Catalogue of Somatic Mutations in Cancer.https://cancer.sanger.ac.uk/cosmic [Google Scholar]
- 36.Lasorella A., Sanson M., Iavarone A. FGFR-TACC gene fusions in human glioma. Neuro Oncol. 2017;19:475–483. doi: 10.1093/neuonc/now240. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 37.Liquori A., Ibañez M., Sargas C., Sanz M.Á., Barragán E., Cervera J. Acute promyelocytic leukemia: a constellation of molecular events around a single PML-RARA fusion gene. Cancers. 2020;12 doi: 10.3390/cancers12030624. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 38.National Cancer Institute Genomic Data Commons . 2021. TCGA Study Abbreviations.https://gdc.cancer.gov/resources-tcga-users/tcga-code-tables/tcga-study-abbreviations [Google Scholar]
- 39.Frattini V., Trifonov V., Chan J.M., Castano A., Lia M., Abate F., Keir S.T., Ji A.X., Zoppoli P., Niola F., et al. The integrated landscape of driver genomic alterations in glioblastoma. Nat. Genet. 2013;45:1141–1149. doi: 10.1038/ng.2734. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 40.Northcott P.A., Shih D.J.H., Peacock J., Garzia L., Morrissy A.S., Zichner T., Stütz A.M., Korshunov A., Reimand J., Schumacher S.E., et al. Subgroup-specific structural variation across 1,000 medulloblastoma genomes. Nature. 2012;488:49–56. doi: 10.1038/nature11327. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 41.Jin K., Wang S., Zhang Y., Xia M., Mo Y., Li X., Li G., Zeng Z., Xiong W., He Y. Long non-coding RNA PVT1 interacts with MYC and its downstream molecules to synergistically promote tumorigenesis. Cell. Mol. Life Sci. 2019;76:4275–4289. doi: 10.1007/s00018-019-03222-1. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 42.Tolomeo D., Agostini A., Visci G., Traversa D., Storlazzi C.T. PVT1: a long non-coding RNA recurrently involved in neoplasia-associated fusion transcripts. Gene. 2021;779 doi: 10.1016/j.gene.2021.145497. [DOI] [PubMed] [Google Scholar]
- 43.Ardini E., Bosotti R., Borgia A.L., De Ponti C., Somaschini A., Cammarota R., Amboldi N., Raddrizzani L., Milani A., Magnaghi P., et al. The TPM3-NTRK1 rearrangement is a recurring event in colorectal carcinoma and is associated with tumor sensitivity to TRKA kinase inhibition. Mol. Oncol. 2014;8:1495–1507. doi: 10.1016/j.molonc.2014.06.001. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 44.Haas B. 2021. Analyses, Code, and Data Supporting the FusionInspector Paper.https://github.com/broadinstitute/FusionInspectorPaper [Google Scholar]
- 45.Boettger L.M., Handsaker R.E., Zody M.C., McCarroll S.A. Structural haplotypes and recent evolution of the human 17q21.31 region. Nat. Genet. 2012;44:881–885. doi: 10.1038/ng.2334. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 46.Zhou J.X., Yang X., Ning S., Wang L., Wang K., Zhang Y., Yuan F., Li F., Zhuo D.D., Tang L., Zhuo D. Identification of KANSARL as the first cancer predisposition fusion gene specific to the population of European ancestry origin. Oncotarget. 2017;8:50594–50607. doi: 10.18632/oncotarget.16385. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 47.Chase A., Ernst T., Fiebig A., Collins A., Grand F., Erben P., Reiter A., Schreiber S., Cross N.C.P. TFG, a target of chromosome translocations in lymphoma and soft tissue tumors, fuses to GPR128 in healthy individuals. Haematologica. 2010;95:20–26. doi: 10.3324/haematol.2009.011536. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 48.The Cancer Genome Atlas Research Network Integrated genomic and molecular characterization of cervical cancer. Nature. 2017;543:378–384. doi: 10.1038/nature21386. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 49.Bass A.J., Lawrence M.S., Brace L.E., Ramos A.H., Drier Y., Cibulskis K., Sougnez C., Voet D., Saksena G., Sivachenko A., et al. Genomic sequencing of colorectal adenocarcinomas identifies a recurrent VTI1A-TCF7L2 fusion. Nat. Genet. 2011;43:964–968. doi: 10.1038/ng.936. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 50.Neuendorff N.R., Burmeister T., Dörken B., Westermann J. BCR-ABL-positive acute myeloid leukemia: a new entity? Analysis of clinical and molecular features. Ann. Hematol. 2016;95:1211–1221. doi: 10.1007/s00277-016-2721-z. [DOI] [PubMed] [Google Scholar]
- 51.Ma X., Liu Y., Liu Y., Alexandrov L.B., Edmonson M.N., Gawad C., Zhou X., Li Y., Rusch M.C., Easton J., et al. Pan-cancer genome and transcriptome analyses of 1,699 paediatric leukaemias and solid tumours. Nature. 2018;555:371–376. doi: 10.1038/nature25795. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 52.Brady S.W., Roberts K.G., Gu Z., Shi L., Pounds S., Pei D., Cheng C., Dai Y., Devidas M., Qu C., et al. The genomic landscape of pediatric acute lymphoblastic leukemia. Nat. Genet. 2022;54:1376–1389. doi: 10.1038/s41588-022-01159-z. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 53.Huang Y., Mouttet B., Warnatz H.J., Risch T., Rietmann F., Frommelt F., Ngo Q.A., Dobay M.P., Marovca B., Jenni S., et al. The leukemogenic TCF3-HLF complex rewires enhancers driving cellular identity and self-renewal conferring EP300 vulnerability. Cancer Cell. 2019;36:630–644.e9. doi: 10.1016/j.ccell.2019.10.004. [DOI] [PubMed] [Google Scholar]
- 54.Hunger S.P., Ohyashiki K., Toyama K., Cleary M.L. Hlf, a novel hepatic bZIP protein, shows altered DNA-binding properties following fusion to E2A in t(17;19) acute lymphoblastic leukemia. Genes Dev. 1992;6:1608–1620. doi: 10.1101/gad.6.9.1608. [DOI] [PubMed] [Google Scholar]
- 55.Inukai T., Hirose K., Inaba T., Kurosawa H., Hama A., Inada H., Chin M., Nagatoshi Y., Ohtsuka Y., Oda M., et al. Hypercalcemia in childhood acute lymphoblastic leukemia: frequent implication of parathyroid hormone-related peptide and E2A-HLF from translocation 17;19. Leukemia. 2007;21:288–296. doi: 10.1038/sj.leu.2404496. [DOI] [PubMed] [Google Scholar]
- 56.Gocho Y., Kiyokawa N., Ichikawa H., Nakabayashi K., Osumi T., Ishibashi T., Ueno H., Terada K., Oboki K., Sakamoto H., et al. A novel recurrent EP300-ZNF384 gene fusion in B-cell precursor acute lymphoblastic leukemia. Leukemia. 2015;29:2445–2448. doi: 10.1038/leu.2015.111. [DOI] [PubMed] [Google Scholar]
- 57.Liu P., Tarlé S.A., Hajra A., Claxton D.F., Marlton P., Freedman M., Siciliano M.J., Collins F.S. Fusion between transcription factor CBF beta/PEBP2 beta and a myosin heavy chain in acute myeloid leukemia. Science. 1993;261:1041–1044. doi: 10.1126/science.8351518. [DOI] [PubMed] [Google Scholar]
- 58.Rocío Juárez-Velázquez D.M.-L., Pérez-Vera P., MartÍnez-Anaya D. 2017. t(X;14)(p22;q32) or t(Y;14)(p11;q32) IGH/CRLF2.http://atlasgeneticsoncology.org/haematological/1769/t(x;14)(p22;q32)-or-t(y;14)(p11;q32)-igh-crlf2 [Google Scholar]
- 59.Russell L.J., Jones L., Enshaei A., Tonin S., Ryan S.L., Eswaran J., Nakjang S., Papaemmanuil E., Tubio J.M.C., Fielding A.K., et al. Characterisation of the genomic landscape of CRLF2-rearranged acute lymphoblastic leukemia. Genes Chromosomes Cancer. 2017;56:363–372. doi: 10.1002/gcc.22439. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 60.Kumar A., Kumar V., Arora M., Kumar M., Ammalli P., Thakur B., Prasad J., Kumari S., Sharma M.C., Kale S.S., Chauhan S.S. Overexpression of prothymosin-alpha in glioma is associated with tumor aggressiveness and poor prognosis. Biosci. Rep. 2022;42 doi: 10.1042/BSR20212685. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 61.Wu K.L., Huang Y.C., Wu Y.Y., Chang C.Y., Chang Y.Y., Chiang H.H., Liu L.X., Tsai Y.M., Hung J.Y. Characterization of the oncogenic potential of eukaryotic initiation factor 4A1 in lung adenocarcinoma via cell cycle regulation and immune microenvironment reprogramming. Biology. 2022;11 doi: 10.3390/biology11070975. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 62.Gazendam A.M., Popovic S., Munir S., Parasu N., Wilson D., Ghert M. Synovial sarcoma: a clinical review. Curr. Oncol. 2021;28:1909–1920. doi: 10.3390/curroncol28030177. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 63.Yan M., Wang J., Ren Y., Li L., He W., Zhang Y., Liu T., Li Z. Over-expression of FSIP1 promotes breast cancer progression and confers resistance to docetaxel via MRP1 stabilization. Cell Death Dis. 2019;10:204. doi: 10.1038/s41419-018-1248-8. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 64.Zhou L., Liu R., Liang X., Zhang S., Bi W., Yang M., He Y., Jin J., Li S., Yang X., et al. lncRNA RP11-624l4.1 is associated with unfavorable prognosis and promotes proliferation via the CDK4/6-cyclin D1-Rb-E2F1 pathway in NPC. Mol. Ther. Nucleic Acids. 2020;22:1025–1039. doi: 10.1016/j.omtn.2020.10.017. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 65.Jaiswal S., Ebert B.L. Clonal hematopoiesis in human aging and disease. Science. 2019;366 doi: 10.1126/science.aan4673. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 66.Lee J.J.K., Park S., Park H., Kim S., Lee J., Lee J., Youk J., Yi K., An Y., Park I.K., et al. Tracing oncogene rearrangements in the mutational history of lung adenocarcinoma. Cell. 2019;177:1842–1857.e21. doi: 10.1016/j.cell.2019.05.013. [DOI] [PubMed] [Google Scholar]
- 67.Gerstung M., Jolly C., Leshchiner I., Dentro S.C., Gonzalez S., Rosebrock D., Mitchell T.J., Rubanova Y., Anur P., Yu K., et al. The evolutionary history of 2,658 cancers. Nature. 2020;578:122–128. doi: 10.1038/s41586-019-1907-7. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 68.Nome T., Hoff A.M., Bakken A.C., Rognum T.O., Nesbakken A., Skotheim R.I. High frequency of fusion transcripts involving TCF7L2 in colorectal cancer: novel fusion partner and splice variants. PLoS One. 2014;9 doi: 10.1371/journal.pone.0091264. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 69.Davidsen J., Larsen S., Coskun M., Gögenur I., Dahlgaard K., Bennett E.P., Troelsen J.T. The VTI1A-TCF4 colon cancer fusion protein is a dominant negative regulator of Wnt signaling and is transcriptionally regulated by intestinal homeodomain factor CDX2. PLoS One. 2018;13 doi: 10.1371/journal.pone.0200215. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 70.Taylor-Weiner A., Stewart C., Giordano T., Miller M., Rosenberg M., Macbeth A., Lennon N., Rheinbay E., Landau D.A., Wu C.J., Getz G. DeTiN: overcoming tumor-in-normal contamination. Nat. Methods. 2018;15:531–534. doi: 10.1038/s41592-018-0036-9. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 71.Nieuwenhuis T.O., Yang S.Y., Verma R.X., Pillalamarri V., Arking D.E., Rosenberg A.Z., McCall M.N., Halushka M.K. Consistent RNA sequencing contamination in GTEx and other data sets. Nat. Commun. 2020;11:1933. doi: 10.1038/s41467-020-15821-9. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 72.Collins R.L., Brand H., Karczewski K.J., Zhao X., Alföldi J., Francioli L.C., Khera A.V., Lowther C., Gauthier L.D., Wang H., et al. A structural variation reference for medical and population genetics. Nature. 2020;581:444–451. doi: 10.1038/s41586-020-2287-8. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 73.Abel H.J., Larson D.E., Regier A.A., Chiang C., Das I., Kanchi K.L., Layer R.M., Neale B.M., Salerno W.J., Reeves C., et al. Mapping and characterization of structural variation in 17,795 human genomes. Nature. 2020;583:83–89. doi: 10.1038/s41586-020-2371-0. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 74.Gingeras T.R. Implications of chimaeric non-co-linear transcripts. Nature. 2009;461:206–211. doi: 10.1038/nature08452. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 75.Grabherr M.G., Haas B.J., Yassour M., Levin J.Z., Thompson D.A., Amit I., Adiconis X., Fan L., Raychowdhury R., Zeng Q., et al. Full-length transcriptome assembly from RNA-Seq data without a reference genome. Nat. Biotechnol. 2011;29:644–652. doi: 10.1038/nbt.1883. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 76.Haas B.J., Papanicolaou A., Yassour M., Grabherr M., Blood P.D., Bowden J., Couger M.B., Eccles D., Li B., Lieber M., et al. De novo transcript sequence reconstruction from RNA-seq using the Trinity platform for reference generation and analysis. Nat. Protoc. 2013;8:1494–1512. doi: 10.1038/nprot.2013.084. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 77.Jerby-Arnon L., Neftel C., Shore M.E., Weisman H.R., Mathewson N.D., McBride M.J., Haas B., Izar B., Volorio A., Boulay G., et al. Opposing immune and genetic mechanisms shape oncogenic programs in synovial sarcoma. Nat. Med. 2021;27:289–300. doi: 10.1038/s41591-020-01212-6. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 78.Liu Q., Hu Y., Stucky A., Fang L., Zhong J.F., Wang K. LongGF: computational algorithm and software tool for fast and accurate detection of gene fusions by long-read transcriptome sequencing. BMC Genom. 2020;21:793. doi: 10.1186/s12864-020-07207-4. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 79.Rautiainen M., Durai D.A., Chen Y., Xin L., Low H.M., Göke J., Marschall T., Schulz M.H. AERON: transcript quantification and gene-fusion detection using long reads. bioRxiv. 2020 doi: 10.1101/2020.01.27.921338. Preprint at. [DOI] [Google Scholar]
- 80.Garalde D.R., Snell E.A., Jachimowicz D., Sipos B., Lloyd J.H., Bruce M., Pantic N., Admassu T., James P., Warland A., et al. Highly parallel direct RNA sequencing on an array of nanopores. Nat. Methods. 2018;15:201–206. doi: 10.1038/nmeth.4577. [DOI] [PubMed] [Google Scholar]
- 81.Kasif S., Roberts R.J. We need to keep a reproducible trace of facts, predictions, and hypotheses from gene to function in the era of big data. PLoS Biol. 2020;18 doi: 10.1371/journal.pbio.3000999. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 82.Haas B.J. 2019. Trinity Cancer Transcriptome Analysis Toolkit.https://github.com/NCIP/Trinity_CTAT/wiki [Google Scholar]
- 83.Bray N.L., Pimentel H., Melsted P., Pachter L. Near-optimal probabilistic RNA-seq quantification. Nat. Biotechnol. 2016;34:525–527. doi: 10.1038/nbt.3519. [DOI] [PubMed] [Google Scholar]
- 84.Haas B.J., Dobin A., Stransky N., Li B., Yang X., Tickle T., Bankapur A., Ganote C., Doak T.G., Pochet N., et al. STAR-fusion: fast and accurate fusion transcript detection from RNA-seq. bioRxiv. 2017 doi: 10.1101/120295. Preprint at. [DOI] [Google Scholar]
- 85.Robinson J. 2019. Igv-Reports.https://github.com/igvteam/igv-reports [Google Scholar]
- 86.Terra Terra: A Scalable Platform for Biomedical Research. https://terra.bio/
- 87.Traag V.A., Waltman L., van Eck N.J. From Louvain to Leiden: guaranteeing well-connected communities. Sci. Rep. 2019;9:5233. doi: 10.1038/s41598-019-41695-z. [DOI] [PMC free article] [PubMed] [Google Scholar]
- 88.Wright M.N., Ziegler A. ranger: A fast implementation of random forests for high dimensional data in C++ and R. J. Statist. Softw. 2017;77:1–17. doi: 10.18637/jss.v077.i01. [DOI] [Google Scholar]
Associated Data
This section collects any data citations, data availability statements, or supplementary materials included in this article.
Supplementary Materials
Data Availability Statement
-
•
This paper analyzes existing, publicly available data. These accession numbers for the datasets are listed in the key resources table.
-
•
All original code has been deposited at GitHub and Zenodo and is publicly available as of the date of publication. URLs and DOIs are listed in the key resources table.
-
•
Any additional information required to reanalyze the data reported in this paper is available from the lead contact upon request.