Skip to main content
Nature Communications logoLink to Nature Communications
. 2022 Feb 28;13:1084. doi: 10.1038/s41467-022-28661-6

Single-cell gene fusion detection by scFusion

Zijie Jin 1, Wenjian Huang 2, Ning Shen 3,4, Juan Li 5, Xiaochen Wang 1, Jiqiao Dong 6, Peter J Park 4, Ruibin Xi 1,7,
PMCID: PMC8885711  PMID: 35228538

Abstract

Gene fusions can play important roles in tumor initiation and progression. While fusion detection so far has been from bulk samples, full-length single-cell RNA sequencing (scRNA-seq) offers the possibility of detecting gene fusions at the single-cell level. However, scRNA-seq data have a high noise level and contain various technical artifacts that can lead to spurious fusion discoveries. Here, we present a computational tool, scFusion, for gene fusion detection based on scRNA-seq. We evaluate the performance of scFusion using simulated and five real scRNA-seq datasets and find that scFusion can efficiently and sensitively detect fusions with a low false discovery rate. In a T cell dataset, scFusion detects the invariant TCR gene recombinations in mucosal-associated invariant T cells that many methods developed for bulk data fail to detect; in a multiple myeloma dataset, scFusion detects the known recurrent fusion IgH-WHSC1, which is associated with overexpression of the WHSC1 oncogene. Our results demonstrate that scFusion can be used to investigate cellular heterogeneity of gene fusions and their transcriptional impact at the single-cell level.

Subject terms: Computational models, Software


Gene fusions are an important class of mutations in tumor genomes. Here, the authors develop a single-cell gene fusion detection method scFusion and demonstrate its applications in cancer single-cell studies.

Introduction

Gene fusions are formed by juxtaposition of parts of two genes, resulting from structural rearrangements such as deletions and translocations1. In cancer cells, many gene fusions are driver mutations that play important roles in carcinogenesis. Well-known examples include BCR-ABL1 in chronic myeloid leukemia2, TMPRSS2–ERG in prostate cancer3, and the ALK fusions in lung cancer4. Some gene fusions are strongly correlated with tumor subtypes and are often used as diagnostic markers for malignancy. Gene fusions are also important targets for cancer drugs. A number of such drugs have been approved by the US Food and Drug Administration such as imatinib targeting BCR-ABL15, crizotinib targeting ALK fusions6, and the recently approved TRK inhibitor larotrectinib targeting NTRK fusions7.

RNA sequencing (RNA-seq) provides an accurate and unbiased platform for gene fusion detection. Gene fusions generate chimeric reads that cover junctions of independent partner genes as well as discordant read pairs whose mates map to the two sides of the junction. After mapping, gene fusions can be detected based on a combination of these split and discordant reads to the partner genes. Gene fusions can also be detected from DNA sequencing data, especially for fusions that are difficult to detect from RNA-seq due to their low expression.

Single-cell RNA sequencing (scRNA-seq)810 technologies have transformed our understanding of transcriptional heterogeneity in tissues. Numerous algorithms have been developed to quantify expression levels, identify clusters of cells belonging to the same cell types, and identify developmental trajectories of single cells11. With the greater coverage along the length of each transcript by recent protocols, another potential application of scRNA-seq is the detection of gene fusions at the single-cell level. Such analysis could help to identify cell subtypes or subclones in which a fusion plays a role and quantify its impact on transcriptomic output. Although many computational fusion detection tools have been developed for bulk RNA-seq data1220, fusion detection using scRNA-seq data is still challenging due to the following: (1) the heavy amplification step may generate artificial chimeric reads, leading to false-positive fusion candidates; (2) the power for detecting fusions shared among multiple single cells can be improved if all single cells are jointly analyzed; (3) current single-cell data often contain thousands or more single cells, making the total size of a collection of cells large, even though the data size for each cell is substantially smaller than that of a bulk RNA-seq sample.

In this paper, we describe a gene fusion detection algorithm named scFusion for scRNA-seq data. scFusion employs a statistical model and a deep-learning model to control for false positives. To assess its performance, we first simulated single-cell data based on real scRNA-seq data and found that scFusion achieved high sensitivity while maintaining a low false discovery rate (FDR). Next, we introduced spike-in fusions experimentally to single cells and validated that those fusions could be detected successfully. Finally, we applied scFusion to four publicly available scRNA-seq data and showed that scFusion identified cell subtypes closely associated with gene fusions.

Results

scFusion detects gene fusions using statistical and machine learning models

scFusion takes as input reads mapped by STAR21 (Fig. 1). Following a standard procedure for fusion detection in bulk RNA-seq, unique split-mapped reads and discordant reads mapped to different genes are identified and clustered to obtain a candidate gene fusion list. After filtering fusion candidates in pseudogenes, long noncoding RNAs (lncRNAs), genes without approved symbols22 (such as RP11-475J5.6), and in the intronic regions, we observed well over 10,000 fusion candidates in most datasets tested (see the following sections). When considering only candidates found in at least two cells, there were still thousands of fusion candidates, nearly all of which are likely to be false positives. For example, the T cells of a hepatocarcinoma scRNA-seq dataset23 had ~1400 fusion candidates shared in at least two cells (excluding candidates involving T cell receptor-related genes). Since these T cells are normal cells, true fusions should be very rare in this dataset. To control for false discoveries, scFusion applies a statistical model and a deep-learning model to filter the potential false positives (“Methods”). Subsequently, scFusion applies two more filters to filter potential false positives that are likely generated by incorrect alignments of short reads (e.g., reads from genes with homologous sequences). If the number of supporting discordant reads for a fusion is more than 10 times that of its supporting split-mapped reads, scFusion filters the fusion candidate. If a gene is in more than five fusion candidates, we filter all fusion candidates involving this gene. The lncRNA and no-approved-symbols filters are optional and users can choose to disable these filters.

Fig. 1. Overview of scFusion for single-cell gene fusion detection.

Fig. 1

The single-cell RNA-seq reads are mapped and supporting reads are identified and clustered to obtain the fusion candidates list. Given the candidate information, a ZINB-based statistical model and a deep-learning model are trained to filter the potential false positives.

There are two assumptions in the statistical model: (1) the candidate fusion list only contains a very small fraction of true fusions, and (2) the true fusion transcripts generally should have more supporting cells/reads than those arising from various experimental and computational artifacts. The distribution of supporting reads that arise due to this background technical noise introduced during sequencing and mapping can be estimated using all candidate fusions. True fusions can be identified if their supporting reads are much larger than those that could be observed from the background distribution. We model the background distribution using the zero-inflated negative binomial (ZINB) distribution. Compared with the Poisson or negative binomial distributions that are often used in scRNA-seq analysis2427, the ZINB distribution can model count data with overdispersion and the excessive number of zeros. The data matrix of supporting chimeric reads has a large number of zeros (>95%) and thus the ZINB model is more suitable. In addition, we observe that, for each fusion candidate, the number of supporting chimeric reads in a cell depends on the expression level of the partner genes and the local GC content (Fig. 2a, b). We describe this dependence using a regression model. Since gene expression is linearly correlated with the supporting read count for the most part (Fig. 2a), the regression functions for the gene expression are chosen to be linear. The GC-content dependency is nonlinear (Fig. 2b), and we use splines to represent this nonlinear relationship. After estimating the parameters of the regression model, we perform statistical tests to determine if the fusion candidates come from the background noise (“Methods”).

Fig. 2. Features of technical chimeric reads.

Fig. 2

The number of supporting chimeric reads depends on (a) the expression of partner genes and (b) the local GC content. The Pearson’s Correlations between the number of chimeric reads and the gene expression and the p-values are shown in the figure. P-values were calculated by two-sided Student’s t test. The GC content was calculated using sequences near breakpoints (200 bp). c The ROCs of the bi-LSTM model for different single-cell datasets (validation data). The AUCs are also shown. d The PR curves and their AUPRs. e The densities of the technical artifact score of gene fusions in the PCAWG study by the bi-LSTM models retrained using six different datasets. f The densities of the predicted probabilities of chimeric reads. The models are retrained using different datasets. Source data are provided as a Source Data file.

The statistical model alone is not sufficient to filter out all false fusion candidates that may be induced during the experimental procedure (e.g., cell lysing, library construction, and sequencing). We observed that the sequences near the junctions of the chimeric reads are enriched with sequences like AAAA and AGGT (Supplementary Fig. 1a), and hypothesized that the technical artifacts might be learned by a machine learning model. We therefore used a bi-directional Long Short Term Memory network (bi-LSTM)28,29 to learn and filter the artifacts (“Methods” and Supplementary Fig. 1b). We set the negative training data as the subsequences from chimeric reads, representing the technical artifacts. Since the number of true fusions is too small for the positive set of the bi-LSTM training, we use as the positive set the sequences generated by concatenating random pairs of short reads (“Methods”). The bi-LSTM assigns each candidate an artifact score from 0 to 1 and candidates with artifact scores greater than 0.75 are filtered.

We first evaluated the performance of the bi-LSTM model using six publicly available scRNA-seq datasets23,3034 from different cancer types. The positive data were the chimeric reads from these data and the negative data were generated as described above. The median of the area under the curve (AUC) was 0.884 and the median area under the precision-recall (PR) curve (AUPR) was 0.913 (Fig. 2c, d). Since the bi-LSTM model was not trained using true fusions, true fusions could be filtered by this model. To evaluate this possibility, we applied the bi-LSTM models trained using six public scRNA-seq data to 3500 gene fusions reported in the Pan-Cancer Analysis of Whole Genomes (PCAWG) studies35,36. The PCAWG fusions can be viewed as gold standard true fusion candidates. The PCAWG fusions and the chimeric reads had artifact scores centered around 0.1 (Fig. 2e) and 0.95 (Fig. 2f), respectively. More than 90% of the PCAWG fusions had artifact scores smaller than 0.5, and only ~5% had scores larger than 0.75. This result indicated that the bi-LSTM model could effectively filter chimeric artifacts at the expense of filtering a very small portion of true fusions. Further, the bi-LSTM did learn features of chimeric artifacts. Chimeric reads with high artifact scores can be partially explained by features such as their junction sequences (Supplementary Fig. 2a–e).

scFusion detects fusions with high sensitivity and precision in simulation

We compared the performance of scFusion with that of directly applying several popular bulk-sample methods (Arriba19, STAR-Fusion20, FusionCatcher13, and EricScript18). We used FusionSimulatorToolkit20 to generate simulation data with 100 fusions from PCAWG at various expression levels (Supplementary Data 1). Since technical chimeric reads cannot be generated by available simulation tools, we added technical chimeric reads using a method mimicking the mis-priming in PCR amplifications37 (“Methods”). We set the percentage of chimeric reads to be 1%, similar to that in the real scRNA-seq data (Supplementary Fig. 3a). We varied single-cell numbers (500 and 1000 cells) and data sizes of single cells (2, 3, and 4 million reads, similar to those in real data; see Supplementary Fig. 3b). In total, we had six different simulation setups and generated ten datasets for each setup. Simulated fusions were randomly added to 20% of cells on average. For bulk methods, we only considered fusions that were reported in at least two cells with at least three supporting reads to reduce their false positives.

Compared with bulk methods, scFusion showed similar levels of recalls but higher levels of precisions and F-scores (Fig. 3, Supplementary Fig. 4, and Supplementary Data 26). For example, in the simulation with 1,000 single cells and 4 million reads per cell, the precision and F-score of scFusion are 0.921 and 0.925, respectively, whereas the precisions of the bulk methods are only 0.434–0.503 and the F-scores are 0.574–0.667.

Fig. 3. The precisions and recalls of scFusion, scFusion without the deep-learning model, and four bulk methods in six different simulation setups.

Fig. 3

The figures in the two rows correspond to simulations with 1000 cells and 500 cells, and the figures in the three columns correspond to simulations with 2 million, 3 million, and 4 million reads in each data. The dots in the figures are the means of precisions and recalls of ten simulations in each setup. The dashed lines are the contour lines with constant F-scores (F-scores are marked in the top-left figure).

To see the effect of the deep-learning model, we also evaluate the performance of scFusion without the deep-learning model. We find that the deep-learning model greatly helps to improve the precision (the precision increases by 0.049–0.168) and only has a minimal influence on the sensitivity (the sensitivity decreases less than 0.04). The fusions missed by scFusion are mostly fusions with low expression levels (Supplementary Fig. 5).

Computational efficiency and effects of the filters in real scRNA-seq data

We considered five scRNA-seq datasets. These include a newly sequenced spike-in dataset (729 cells), a T cell dataset23 from a liver cancer study (2355 cells), a multiple myeloma dataset33 (597 cells), and two prostate cancer datasets31,38 (288 cells and 922 cells, respectively). Details about the data are described below. We first compared the computational time of different algorithms in these datasets (Fig. 4a). The computational time of scFusion is only about a half of Arriba and ~30% or less of STAR-Fusion, EricScript, and FusionCatcher, demonstrating the superior computational efficiency of scFusion. Figure 4b shows the effects of different filters in the scRNA-seq data. The statistical model is responsible for filtering most of the potential false positives.

Fig. 4. The computational time and effects of scFusion’s filters.

Fig. 4

a The computational time of the five methods for fusion detection in five scRNA-seq data. The y-axis is the total CPU hours of each method. b Number of fusion candidates after each filter. The top is the total number of fusion candidates, and the second layer is the number of fusion candidates after excluding candidates involving pseudogenes, lncRNAs, genes without an approved symbol, and in intronic regions (they are called pseudogene-, lncRNA-, no-approved-symbol-, and intron- filters). The third layer is the number of candidates supported by at least 2 cells. The fourth layer shows the numbers of fusion candidates remained after the filtering by the statistical model and the deep-learning model, respectively. The fifth layer is the number of candidates that pass both models. The last number indicates the number of output fusions after removing candidates with a partner gene involving in more than five fusion candidates and candidates whose number of supporting discordant reads is ten times more than their supporting split-mapped reads (too-many-partner- and too-many-discordant- filters).

scFusion detects fusions with low false discoveries in a spike-in dataset

To test whether scFusion can detect fusions in real scRNA-seq data, we introduced 27 known gene fusions to 27 single cells before performing single-cell sequencing8,9 (“Methods” and Supplementary Data 7). All 27 fusions are from the PCAWG gene fusion study35,36 and include well-known fusions such as EML4-ALK, ROS1-GOPC, and TMPRSS2-ERG. In total, we obtained scRNA-seq data from 729 single cells (~30 supporting reads for each fusion in each cell). scFusion reported all 27 spike-ins as well as 24 other fusions (Supplementary Data 8). All bulk methods except EricScript also detected all the spike-ins (Fig. 5a and Supplementary Data 912), but they reported a large number of fusions (310–9044, Fig. 5b), indicating their potentially high FDRs. We also performed bulk RNA-seq for the spike-in samples. 80% (41) of the fusions detected by scFusion were the spike-in fusions or had supporting chimeric reads in the bulk data, in contrast to the much lower percentage (0.5–17.7%) for the bulk methods (Fig. 5c), again indicating that the FDR of scFusion is much lower than the bulk methods.

Fig. 5. The performance of five methods on spike-in data.

Fig. 5

a The numbers of reported spike-in fusions. b The numbers of reported fusions. c The proportions of fusions having bulk supporting chimeric reads or in the 27 spike-ins.

scFusion demonstrates high sensitivity in detecting marker fusions in a T cell dataset

Another dataset we tested consists of 2355 T cells selected from ~7000 immune cells in patients with liver cancer23. The T cells of this population are non-malignant cells. Thus, other than the V(D)J recombinations of TCR genes, gene fusions should be very rare in these cells. scFusion identified eight gene fusions, much fewer than bulk methods (Fig. 6a, Supplementary Data 1317). Among the fusions detected by scFusion, six involve TCR genes, and four (50%) are V(D)J recombinations, indicating that many of these candidates are likely true positives. In comparison, only one (1.8%) of STAR-Fusion candidates are V(D)J recombinations and no candidates of other bulk methods are V(D)J recombinations (Fig. 6b). The two most frequent V(D)J recombinations identified by scFusion are TRAJ33-TRAV1-2 and TRAJ12-TRAV1-2, with 126 and 20 supporting cells, respectively. Mucosal-associated invariant T (MAIT) cells are known to express the invariant TRAJ33-TRAV1-2 and TRAJ12-TRAV1-2 TCR α-chain23,39. Thus, the single cells with one of these fusions are likely MAIT cells. SLC4A10, a marker gene of MAIT cells40, was expressed only in a cluster of T cells and many in this cluster had the TRAJ33-TRAV1-2 or TRAJ12-TRAV1-2 fusion (Fig. 6c, d). Differential expression analysis between the cells with and without these recombinations identifies 70 upregulated genes in the cells with the recombinations, among which TRAJ33, TRAV1-2, and SLC4A10 are the top three most significantly upregulated genes (Supplementary Fig. 6a, b). Further, the SLC4A10 expression is significantly associated with the fusion (Fisher’s exact test, P-value < 10−16; Table 1).

Fig. 6. The T cell scRNA-seq data.

Fig. 6

a The number of detected gene fusions by the five methods. b The percentages of V(D)J recombinations in fusions detected by the five methods. c The expressions of SLC4A10 shown in the tSNE plot of all T cells. d The cells with TRAJ33-TRAV1-2 and TRAJ12-TRAV1-2 colored in the tSNE plot. e, f The barplots of numbers of cells with the TRAJ33-TRAV1-2 (e) and TRAJ12-TRAV1-2 (f) recombinations by different algorithms. Source data are provided as a Source Data file.

Table 1.

The contingency table between the TRAJ33-TRAV1-2/TRAJ12-TRAV1-2 fusion and the expression of SLC4A10.

TRAJ33-TRAV1-2/TRAJ12-TRAV12 Other
High expression 108 90
Low expression 40 2,117

The high expression indicates the cells whose SLC4A10 expression is greater than 1 and the low expression are other cells. Fisher’s exact test (two-sided) gives a p-value smaller than 10−16.

These results indicate that the TRAJ33-TRAV1-2 and TRAJ12-TRAV1-2 fusions identified by scFusion are bona fide fusions and the cells with either fusion are MAIT cells. MAIT cells are an important component of the immune system. However, until recently, the detection of MAIT cells still relied on the combinations of cell markers and it is unclear how well these markers define the MAIT cells in different tissues or diseases41. scFusion provides an alternative way to sensitively define the MAIT cells. STAR-Fusion was the only bulk method that identified the TRAJ33-TRAV1-2 fusion (62 cells) (Fig. 6e), and no bulk method reported any cells having the TRAJ12-TRAV1-2 fusion (Fig. 6f), indicating that scFusion is more powerful in detecting shared fusions among single cells.

Sensitive fusion detection by scFusion provides mechanistic insights in a multiple myeloma dataset

We applied scFusion to a multiple myeloma (MM) dataset consisting of 597 single cells from 15 patients33. MM is a cancer of plasma cells. Approximately half of the myelomas have immunoglobulin heavy (IgH) chain translocations and around 10% of the myelomas have translocations involving immunoglobulin lambda (IgL) light chain locus42,43. In this dataset, scFusion identified 38 fusions while the bulk methods identified many more (41 to 1492, Fig. 7a, Supplementary Data 18-22). Around 94.7% (36) of scFusion candidates involve immunoglobulin genes (including 33 recombinations of immunoglobin genes), much higher than that for bulk methods. (Fig. 7b). scFusion successfully identified the recurrent IgH-WHSC1 fusion in MM with two different breakpoints within WHSC1, positions 1902353 and 1905943 on chromosome 4 (Supplementary Data 18). The IgH-WHSC1 fusions are in-frame fusions of WHSC1. All 52 cells with the breakpoint at 1902353 are from the patient SMM0. Similarly, all 20 cells with the other breakpoint are from the patient RRMM2 (Fig. 7c).

Fig. 7. The MM scRNA-seq data.

Fig. 7

a The number of detected gene fusions by the five methods. The percentage of IgH-related fusions in fusions detected by the five methods. c The tSNE plot of all MM single cells. The cells with two IgH-WHSC1 fusions are colored in the plot. The cells from patient RMM2 and SMM0 are marked by triangle and rectangle, respectively. d The expression of WHSC1 shown in the tSNE plot. e The mean read depth of WHSC1 at different locations for the cells with the two IgH-WHSC1 fusions and the cells without the fusions. The black triangles indicate the breakpoints of the two fusions. The supporting number of splicing junctions are also shown in the plot (the numbers above the arcs). The read depth of a single cell at a location is calculated as the number of reads covering the location per million. The mean read depth is the average depth of all cells in a group. f The barplots of numbers of cells with the IgH-WHSC1 fusions by different algorithms. Source data are provided as a Source Data file.

The expression of WHSC1 is significantly higher in cells with the WHSC1 fusions than in other cells (Fig. 7d). Interestingly, in cells with the WHSC1 fusions, the sequencing coverage of WHSC1 sharply increases downstream of the breakpoints, but the sequencing coverage of WHSC1 in other cells is largely kept constant, indicating that the fusions probably lead to the overexpression of WHSC1 (Fig. 7e and Supplementary Fig. 6c). WHSC1, also known as NSD2 and a known oncogene44, is one of the most commonly-fused partners with IgH in multiple myeloma4547. Overexpression of WHSC1 drives the chromatin change in an H3K36me2-dependent manner48. Differential expression analysis found 115 upregulated genes and 12 downregulated genes in the cells with the IgH-WHSC1 fusions (q-value < 0.05 and log2 fold-change < −0.5 or >0.5) (Supplementary Fig. 6d and Supplementary Data 23). The upregulated genes include genes known to be co-expressed with WHSC1 such as MAL49 and SCARNA2250. The downregulated genes include known oncogenes in MM such as CCND1 and FRZB. In fact, CCND1 and FRZB tend to only express in cells without the IgH-WHSC1 fusions (Supplementary Fig. 6e, f).

The bulk methods also detected the IgH-WHSC1 fusions, but they reported fewer number of cells with the fusions than scFusion (Fig. 7f) and potentially many more false positives (Fig. 7a, b). The large number of false positives given by the bulk methods makes it very difficult for downstream analysis, thus limiting their application in single-cell analysis.

scFusion detects known fusions in prostate cancer datasets

Finally, we applied scFusion to two prostate datasets, from the cancer cell line LNCaP with 288 cells (LNCaP data)31 and from 14 prostate cancer patients (prostate patient data)38. scFusion detected 4 fusions in the LNCaP data whereas the bulk methods detected 14–288 fusions (Supplementary Fig. 7a and Supplementary Data 2428). We compared the detected fusions with the fusions of the LNCaP cell line listed in the Cancer Cell Line Encyclopedia (CCLE) database. All of the four fusions reported by scFusion are in the CCLE fusion database and only 2.4–42.9% by the bulk methods are in the database, again indicating the high precision of scFusion. It is known that the LNCaP cell line does not have the well-known TMPRSS2-ERG fusion in prostate cancers51. Consistent with this fact, no method detected the fusion.

The prostate patient dataset contains more single cells (922 epithelium cells), but the read length is only 38 bp, making fusion detection more difficult. scFusion only reported 10 fusions including TMPRSS2-ERG in 27 cells. The bulk methods reported 23–113 fusions including TMPRSS2-ERG in 17–26 cells (Supplementary Fig. 7b, c, and Supplementary Data 2933). The cells reported to harbor the TMPRSS2-ERG fusions by different algorithms are largely consistent with scFusion (Supplementary Fig. 7d). Differential expression analysis shows that ERG is highly expressed in cells with the TMPRSS2-ERG fusion (Supplementary Fig. 7e), consistent with the previous research that TMPRSS2-ERG could lead to the overexpression of ERG52. Patient 1115655 had the largest number of cells (21) with the TMPRSS2-ERG fusion. scRNA-seq data of this patient before and after the enzalutamide (an androgen receptor inhibitor) treatment are available. Before the enzalutamide treatment, 16.7% (18/108) of cells contain the fusion, a much higher fraction than in cells after the treatment (3.7% or 3/81), consistent with the previous observation that the TMPRSS2-ERG fusion can confer efficacy of enzalutamide53 (Table 2). Differential expression analysis also shows that ERG is significantly downregulated in the cells after the treatment (Supplementary Fig. 7f).

Table 2.

The contingency table between the TMPRSS2-ERG fusion and the enzalutamide treatment.

With the fusion Without the fusion
Before treatment 18 90
After treatment 3 78

The Fisher’s exact test (two-sided) gives a p-value of 0.0047.

Discussion

A major challenge in fusion detection in single cells is the large number of false positives obtained when conventional methods are applied. To address this challenge, we introduced a statistical testing procedure to control the FDR. This procedure assumes that most fusion signals originate from technical noise and that true fusions generally have stronger signals than false positives. To remove systematic artifacts that may occur recurrently in multiple single cells (e.g., due to mis-priming during PCR amplification37), we developed a deep-learning model to learn the unknown technical artifacts and to filter the false positives generated by these artifacts. Another important difference compared to existing bulk methods is that scFusion takes advantage of the fact that multiple cells from a sample should contain the same fusion. Rather than considering each sample independently as bulk methods do, scFusion performs joint analysis of related cells, thus substantially increasing the detection power.

Although we have attempted to maximize its detection power, scFusion has reduced sensitivity for fusions with low expression (as shown in the simulation), just as is the case for all RNA-based methods. The detection power is also limited for rare fusions in highly heterogeneous tumor samples. These inherent limitations can be overcome only by sequencing more cells and/or sequencing each cell deeper.

One important application of scFusion, as illustrated by our detection of MAIT cells in our T cell data, is that fusions can serve to identify a subpopulation of cells in a given sample. Cells are typically clustered based on the expression level of a known marker gene or based on the overall similarity of the transcriptional profiles. However, choosing the appropriate thresholds to define distinct populations is a difficult issue. The presence of fusion transcripts would be one way of distinguishing a subpopulation, thus aiding in the cell type annotation task. Identifying such subpopulations may prove invaluable in studying drug-resistant or drug-sensitive subclones in a tumor.

In the real data analysis, we found that scFusion generally detected much fewer fusions compared with the bulk methods. Among the fusions detected by the bulk methods, many were very likely to be technical artifacts (Supplementary Fig. 8). For example, the GADD45G-HSPH1 fusion was identified by all four bulk methods, but it contained a poly-A subsequence and its artifact score was almost 1. When deep-learning model was turned off, the precisions of scFusion reduced (Fig. 3, Supplementary Fig. 4, 9, and 10). We also noticed that many potential artifacts were also filtered by the ad hoc filters (Supplementary Fig. 11).

MAIT cells in humans are known to express three TCR α-chains, of which the most abundant is TRAJ33-TRAV1-241. scFusion identified two of the three and found that TRAJ33-TRAV1-2 is about 6 times more abundant than TRAJ12-TRAV1-2. The TRAJ20-TRAV1-2 was not identified possibly because it was rare in MAIT cells. Gene differential expression analysis discovered 15 genes significantly differentially expressed between TRAJ33-TRAV1-2 and TRAJ12-TRAV1-2 cells (Supplementary Data 34). Interestingly, ALPK1 and TIFA are highly expressed in the cells with TRAJ12-TRAV1-2 (Supplementary Fig. 12). Recent studies54 show that ALPK1-TIFA axis is a core innate immune pathway against pathogens such as Helicobacter pylori, implying that MAIT cells expressing different TCR α-chains might have different roles in the immune system. In the MM data, the IgH-WHSC1 fusions are the most significant immunoglobulin-related fusions reported by scFusion, leading to the overexpression of the oncogene WHSC155. WHSC1 is highly expressed in single cells from three patients (SMM0, RRMM1, and RRMM2). scFusion did not find WHSC1 fusions in single cells from RRMM2. It is likely that the expression of WHSC1 was activated in RRMM2 by mechanisms other than WHSC1 fusions or that the fusion was missed by scFusion.

The scRNA-seq technology continues to improve, both in terms of the number of genes captured and the evenness of coverage across each transcript. As its data quality approaches that of bulk RNA-seq data, it will enable a more comprehensive profiling of fusion transcripts. We expect that scFusion and the statistical/machine learning framework introduced therein will find useful applications in future single-cell studies.

Methods

Statistical Model

Suppose that there are n cells and N fusion candidates. Let yij be the number of split-mapped reads supporting a fusion candidate i in a cell j. The fusion candidate i can either be a true fusion or from the background noises. If the distribution of the background noises is known, we can perform a statistical test to test if the observed numbers of supporting reads yij’s (j=1,,n) fit well to the distribution of the background noise. Candidates with significant p-values would be more likely to be true fusions. However, we do not know the distribution of the background noises and hence we need to first estimate this distribution. scRNA-seq data are count data and are often modeled by Poisson, negative binomial (NB) or zero-inflated negative binomial (ZINB) distributions2427. The ZINB distribution is the most generalized version of these distributions. Since the data matrix of supporting chimeric reads has an excessive number of zeros (>95%), we assume that the distribution of the background noises is a ZINB distribution25. Estimating the distribution can be achieved by estimating the parameters in the ZINB distribution. Since we observed that the number of supporting chimeric reads depended on covariates such as the local GC content and expressions of partner genes (Fig. 2a, b), we establish a regression model to link the parameters in the ZINB distribution and the covariates. The parameters of the regression model can be estimated by the maximum likelihood estimation. Details of the model are given below.

Denote Yij the random variable corresponding to yij. Since the candidate fusions have very few true fusions, we can safely use all yij to estimate the distribution of the background noises. Assume that Yij follows the ZINB distribution25. The ZINB distribution has three parameters. One parameter is pi, the probability that the cell j has no split-mapped read supporting the fusion candidate i or pi=PYij=0. The other two parameters of the ZINB are the mean μij and the overdispersion parameter λ of the negative binomial (NB) distribution. Thus, we have Yij~ZINB(pi,μij,λ). Conditional on Yij>0, Yij follows a zero-truncated NB distribution. We assume that the ZINB distribution depends on the expression levels of the partner genes and the GC content56. Let e1ij<e2ij be the expressions of the two partner genes corresponding to Yij and ti be the GC content of the exonic sequence near the junction of the candidate gene (200 bp). Further, define ē1i<ē2i as the mean expression of the two partner genes of the candidate fusion i across all single cells. The gene expression is largely linearly dependent on the supporting read number (Fig. 2a) and the regression functions against the gene expression is set as linear. The GC-content dependency is nonlinear (Fig. 2b) and is represented by spline functions. Thus, we consider the following regression model

logitpi=β10+fti+β11ē1i+β12ē2i, 1
logμij=β20+gti+β21e1ij+β22e2ij, 2

where f and g are unknown functions, and the β1=(β10,β11,β12) and β2=(β20,β21,β22) are unknown parameters. We represent f and g using spline functions, f(x)=k=1KβkfBk(x) and g(x)=k=1KβkgBk(x), where K is the number of spline base functions (by default K is set as 5). Denote θ=(β1,β2,βf,βg) with βf=(β1f,βKf) and βg=(β1g,βKg). We estimate the unknown parameters θ by maximizing the following likelihood (MLE),

lβ1,β2,λ=i=1Nliθj=1n1yij>02, 3
liθj=1n1yij>02=pij=1n1yij=0j:yij>0ϕyij;μij,λ1ϕ0;μij,λ1pinn1pipin1, 4

where N is the number of fusion candidates supported by at least 2 cells, n is the number of cells, ϕ is the probability density function of NB distribution with mean μijand overdispersion λ. Note that to reduce the computational burden, we only consider the candidates with at least two supporting cells and thus the likelihood li for the candidate i is a conditional probability.

Statistical Test for Significant Fusions

Plugging-in the MLE estimates of the regression parameters, we can estimate the background noise distribution for each fusion candidate. With the distribution estimate, we can test if the observed number of supporting chimeric reads for the fusion candidate is likely to be sampled from the background distribution. If the background distribution is unlikely to generate an observation that is larger than the observed supporting reads number, or in other words, if we obtain a very small p-value, we reject the null hypothesis that the fusion candidate is from the background noise and retain the fusion as a true fusion candidate. Details of the testing procedure are given below.

Let θ^=(β^1,β^2,β^f,β^g) and λ^ be the MLE of the parameters θ and λ, respectively. Plugging-in θ^ to the formula (1) and (2), we can get the parameter estimates p^i,μ^ijand λ^ of the ZINB distribution and can estimate the ZINB distribution by ZINB(p^i,μ^ij,λ^). We use a resampling scheme to obtain a p-value for each fusion candidate. Specifically, for each fusion candidate i, we sample Y~ij(b)from ZINB(p^i,μ^ij,λ^) for each cell j and obtain the sum S~i(b)=j=1nY~ij(b) (b=1,,B). Denote ν~i and σ~i2 be the sample mean and variance of S~i(b), respectively. The distribution of S~i(b) can be approximated by a normal distribution with the mean and variance approximately ν~i and σ~i2, respectively. Let Si=j=1nYij. The p-value for the fusion candidate i is set as pi=1Φ((Siν~i)/σ~i), where Φ is the cumulative distribution of the standard normal distribution. We set B=1000 in all analyses.

To determine a p-value cutoff to control the FDR, we split our candidate fusion set into two subsets. The first subset is a high-quality subset that more likely contains the true gene fusions and the second subset is the remaining candidates. Suppose that n1 and n2 as the total number of candidates in the first and the second subset, respectively. Given a p-value cutoff c, let m1(c) and m2(c) be the number of candidates in the two subsets with p-values less c, respectively. Since the second subset contains much fewer true positives than the first subset, (n1+n2)m2(c)n2can be used as an estimate of total number of false discoveries at the p-value cutoff c and thus the FDR is roughly fdrc=m2(c)n2n1+n2m1c+m2(c). We choose c such that fdrcα for a given α (usually 0.05). In general, we believe that candidates with more supporting cells are more likely to be true. Hence, we choose the first subset as the fusion candidates with at least 1% of the total cells having the fusion and with at least s supporting reads per cell on average, where s is taken as 1.25 in all simulation and real data analysis.

The bi-LSTM

Each single cell usually has over 10,000 chimeric reads (Supplementary Fig. 3c) and the vast majority of them are obviously not signals of gene fusions but technical artifacts. We set the negative training data as the subsequences from chimeric reads, representing the technical artifacts. An ideal positive training data would be chimeric reads from true fusions. Unfortunately, we do not know which chimeric reads are from true fusions. Even if we knew some, the number of such reads would be too small to train the bi-LSTM network. To overcome this challenge, a proxy task strategy is applied: we set the positive training data as sequences generated by concatenating random pairs of short reads. Since the sequences are randomly generated, they should not contain features of technical chimeric reads and hence characteristics of technical artifacts could be learned by comparing with these random sequences. More specifically, the negative training data of the bi-LSTM is chosen as the subsequences (60 bp) of chimeric reads covering the junction positions and the junction positions are required to be at 15-45 bp of the subsequences. The positive training data is the similar 60 bp subsequences of randomly concatenated short read pairs.

In the bi-LSTM (Supplementary Fig. 1b), the DNA sequences, with 60 nucleotides and one fusion site, are given as the input to the embedding layer. The four types of nucleotide (i.e., A, T, G, and C) and the fusion site are represented by five different 5-dimensional feature vectors. The output of the embedding layer is passed on to three sequence-to-sequence bi-LSTM layers (with 32, 64, and 128 bi-LSTM units, respectively) and further to a sequence-to-one bi-LSTM layer for sequential feature extraction. The extracted features are fed to two fully connected layers and finally to a softmax layer to produce the softmax probabilities of the read being classified to technical chimeric artifacts. In the training process, the binary cross-entropy is used as the loss function and model parameters are updated using the Adam optimizer57. The model is pre-trained for 200 epochs with the batch size set to 500.

Using this bi-LSTM model, scFusion gives each fusion candidate a technical artifact score. By default, fusions with scores greater than 0.75 are filtered. The training step is computationally expensive. To expedite the training, scFusion provides a pre-trained model that can be used as the initial value to train bi-LSTM models for new datasets. The retraining is trained for 30 epochs with the pre-trained model as the initial value. Note that if we directly used the pre-trained model, the median AUC and AUPR were 0.673 and 0.749 (Supplementary Fig. 2f, g), respectively. The convolutional neural network (CNN) is another popular neural network model used in many biological applications58. We also built a CNN model for comparison and found that the bi-LSTM generally performed better than the CNN (Supplementary Material, Supplementary Fig. 13). Hence, we use the bi-LSTM in all data analyses.

Simulation setup

The simulation data was generated using FusionSimulatorToolkit20. This toolkit can simulate RNA-seq data with gene fusions by learning from a real RNA-Seq dataset such as its expression, insert size, read length and mutation rate. We provided the immune cell scRNA-seq23 data to FusionSimulatorToolkit to train a single model and provided this model to FusionSimulatorToolkit to generate RNA-seq data with 100 simulated fusions from PCAWG at various gene expression levels. For technical chimeric artifacts, we design a new method to add technical chimeric artifacts to the simulated data. Briefly speaking, we randomly sample transcript pairs to generate technical fusions between the sampled transcript pairs. The sampling probabilities of the transcript pairs depend on their sequence features to mimic the random annealing and mis-priming in PCR amplification37. After a technical fusion is introduced to a cell, we further assign a random expression to the technical fusion and add short reads from the fusion to the cell.

More specifically, given any two transcripts T1 and T2 (or their reverse complements) and their potential breakpoints b1,b2, we define a mis-priming likelihood

AT1,b1,T2,b2=11+exp1803ψT1,b1,T2,b2, 5

where ψ(T1,b1,T2,b2) is the “binding energy” between T1 and T2 near the breakpoints b1, b2. Here, we define

ψT1,b1,T2,b2=i=16ϕS1i,S2i, 6

where S1=S11S16 (S2=S21S26) is the 6-mer subsequence of T1(T2) near b1(b2), ϕA,T=ϕT,A=12, ϕG,C=ϕC,G=21 and ϕN1,N2=0 for all other nucleotide pairs (N1,N2). Then, using AT1,b1,T2,b2 as the weighting probability, we randomly generate a library of 2.2 million potential technical chimeric sequences. If T1,b1,T2,b2 is sampled, the corresponding chimeric sequence is chosen as T11T22, where T11 is the subsequence of T1 upstream of b1 and T22 is the complementary of the subsequence of T2 downstream of b2. Then, for each cell, we randomly select chimeric sequences from this library with a new sampling weight

WT1,b1,T2,b2=ψT1,b1,T2,b21+exp1953ψT1,b1,T2,b2 7

and generate chimeric short reads from the selected sequences. The expressions of the technical chimeric sequences are randomly sampled from 1 to 100. The total number of chimeric reads for each cell is set as around 1% of the total number of reads, at the similar level as real scRNA-seq data.

Gene fusion spike-in and single-cell sequencing

cDNA sequences of 27 fusion genes were synthesized and constructed into independent lentiviral vectors. Every lentiviral vector along with two auxiliary packaging plasmids was co-transfected into independent 293T cells. After 48 hours, the supernatant was collected from the 293T cells and filtered through a 0.45 uM membrane. The 27 different recombinant lentiviral particles containing the target fusion genes and the green fluorescent protein (GFP) reporter gene were collected. Then, the 27 recombinant lentivirus particles were infected into 293 T cells, respectively. 72 hours after infection, the medium was changed and the expression of GFP in cells was checked under a fluorescence microscope to determine if lentivirus infection was successful. After the infection, 27 cell cultures expressing different target fusion genes were collected. The collected cells were washed with 1x PBS and resuspended with 2 mL PBS. Single-cell sorting was performed on the BD Biosciences FACS-ARIA platform and the single GFP positive cells (27 cells from each of the 27 cell cultures) were screened into 96-well PCR plates, respectively, for the next step of single-cell RNA library construction. Poly(A)-transcripts of total RNA of single cells were reverse transcribed and amplified using the SMART-seq2 protocol. The amplified cDNA was tagmented by Nextera XT kit (Illumina) and libraries were sequenced by NovaSeq (Illumina). The 293 T cells were purchased from the National Infrastructure of Cell Line Resource (http://www.cellresource.cn/).

scRNA-seq data analysis

For scFusion, short reads are first aligned with STAR(v 2.7.4a) to the human reference genome (hg19). scFusion only considers short reads mapped to uniquely mappable positions in the exonic regions of the reference genome (uniquely mappable for 75 bp sequences). Then, the split-mapped reads are clustered. If the breakpoints of two split-mapped reads are no larger than 20 bp away from each other, the two split-mapped reads are clustered together. A fusion candidate’s breakpoint is taken as the median of the breakpoint positions of its all supporting chimeric reads.

FusionCatcher(v1.10) was run on the default parameters. Arriba(v1.0.1), EricScript(v0.5.5b), and STAR-Fusion(v1.8.1) were all run on the default parameters except the minimum-supporting-reads parameter. We tuned the minimum-supporting-reads parameter for all bulk methods except FusionCatcher (since it does not have any tuning parameter) using the simulation data. We found that the bulk methods had the highest F-scores when the parameter was set as three. So we set the minimum-supporting-reads parameter as 3 for EricScript, STAR-Fusion and Arriba in all data analyses. The reference genome was chosen as hg19. For the bulk methods, we also applied the same ad hoc filters of scFusion to make different algorithms comparable. Specifically, we applied the pseudogene-, lncRNA-, no-approved-symbol-gene-, intron-, too-many-partner- and too-many-discordant- filters to the fusion candidates of bulk methods. lncRNA- and no-approved-symbol-gene- filters are optional, and Supplementary Fig. 14 shows the numbers of detected fusions in each dataset when these two filters are turned off.

Gene expression analysis

The expression matrix of T cell and the multiple myeloma dataset were downloaded from the Gene Expression Omnibus (GEO) (https://www.ncbi.nlm.nih.gov/geo/). First, we used Seurat (v 3.2.0)59,60 to read the Transcripts Per Million (TPM) matrix. The expression was further normalized using the NormalizeData function in Seurat. The highly variable genes were identified using the function FindVariableGenes. Their expression was scaled and centered along each gene using ScaleData. Then we performed dimension reduction using principal component (PC) analysis. We selected the first 30 PCs for t-distributed stochastic neighbor embedding (tSNE), and tSNE plots were generated using Seurat. To identify differentially expressed genes, we used the function FindAllMarkers in Seurat with the Wilcoxon rank-sum test. Genes expressed in at least 10% cells within the cluster and with the log fold-change more than 0.5 and the adjusted p-value smaller than 0.05 were considered as differentially expressed genes.

Statistics and Reproducibility

The linear correlation tests were performed by two-sided Student’s t test. The significance of difference in the contingency tables was tested by Fisher’s exact test (two-sided). The tests on differential expressed (DE) genes were performed by two-sided Wilcoxon rank-sum test adjusted by Benjamini-Hochberg procedure. A p-value or adjusted p-value lower than 0.05 was considered significant.

In this study, we spiked-in gene fusions to single cells and performed single-cell RNA sequencing using SMART-seq2 to evaluate the fusion detection algorithm. Simulation showed that sensitive detection of gene fusions need ~20 cells for each fusion and we chose to spike-in 27 cells for each fusion. We chose to spiked-in 27 gene fusions for stable evaluation of the algorithms. This gave us 729 cells of scRNA-seq data, largely similar to the cell numbers in studies using full-length scRNA-seq techonologies23,33. No statistical method was used to predetermine sample size. No data were excluded from the analyses. The experiments were not randomized. The Investigators were not blinded to allocation during experiments and outcome assessment.

Reporting summary

Further information on research design is available in the Nature Research Reporting Summary linked to this article.

Supplementary information

Reporting Summary (363.8KB, pdf)
Peer Review File (4.8MB, pdf)
41467_2022_28661_MOESM4_ESM.pdf (68KB, pdf)

Description of Additional Supplementary Files

Supplementary Data 1 (13.7KB, xlsx)
Supplementary Data 2 (79.5KB, xlsx)
Supplementary Data 3 (97.3KB, xlsx)
Supplementary Data 4 (87.4KB, xlsx)
Supplementary Data 5 (115.3KB, xlsx)
Supplementary Data 6 (97.2KB, xlsx)
Supplementary Data 7 (10.1KB, xlsx)
Supplementary Data 8 (26.8KB, xlsx)
Supplementary Data 9 (51.2KB, xlsx)
Supplementary Data 10 (121.3KB, xlsx)
Supplementary Data 11 (1MB, xlsx)
Supplementary Data 12 (45.8KB, xlsx)
Supplementary Data 13 (13.6KB, xlsx)
Supplementary Data 14 (16.8KB, xlsx)
Supplementary Data 15 (37.3KB, xlsx)
Supplementary Data 16 (333.5KB, xlsx)
Supplementary Data 17 (13.9KB, xlsx)
Supplementary Data 18 (22.2KB, xlsx)
Supplementary Data 19 (12.8KB, xlsx)
Supplementary Data 20 (15.9KB, xlsx)
Supplementary Data 21 (156.5KB, xlsx)
Supplementary Data 22 (17.1KB, xlsx)
Supplementary Data 23 (16.5KB, xlsx)
Supplementary Data 24 (10.2KB, xlsx)
Supplementary Data 25 (10.2KB, xlsx)
Supplementary Data 26 (40.5KB, xlsx)
Supplementary Data 27 (15.1KB, xlsx)
Supplementary Data 28 (12.5KB, xlsx)
Supplementary Data 29 (18.8KB, xlsx)
Supplementary Data 30 (16.8KB, xlsx)
Supplementary Data 31 (22KB, xlsx)
Supplementary Data 32 (11.9KB, xlsx)
Supplementary Data 33 (11.3KB, xlsx)
Supplementary Data 34 (14KB, xlsx)

Acknowledgements

This work was supported by the National Natural Science Foundation of China [No. 11971039 to R.X.], the National Key Basic Research Program of China [2020YFE0204000 to R.X.], and Sino-Russian Mathematics Center. Part of the analysis was performed on the High Performance Computing Platform of the Center for Life Sciences (Peking University).

Source data

Source data (86.7MB, xlsx)

Author contributions

R.X. conceived and supervised the study. Z.J. developed the statistical model. W.H., Z.J., and X.W. developed the deep-learning model. J.L. and J.D. performed the single-cell experiment. Z.J., R.X., and N.S. performed data analysis. R.X., Z.J., N.S., W.H., and X.W. wrote the manuscript, with important feedback from P.P.

Peer review

Peer review information

Nature Communications thanks the anonymous reviewer(s) for their contribution to the peer review of this work. Peer reviewer reports are available.

Data availability

Raw data of the spike-in data generated in this study have been deposited in the Genome Sequence Archive (GSA) of BIG Data Center, Beijing Institute of Genomics (BIG), Chinese Academy of Sciences, with an accession code HRA001199. The scRNA-seq data used in this study are available in Gene Expression Omnibus (GEO) under accession code GSE81812, GSE99795, GSE110499, GSE118900, GSE127298, GSE140228. Raw sequence data of the prostate patient data used in this study are available in dbGaP under accession codephs001988.v1.p1 (https://www.ncbi.nlm.nih.gov/projects/gap/cgi-bin/study.cgi?study_id=phs001988.v1.p1). Source data are provided with this paper.

Code availability

scFusion is available at GitHub (https://github.com/XiDsLab/scFusion)61.

Competing interests

The authors declare the following competing interests: Ruibin Xi holds the stock of GeneX Health Co.Ltd. A patent application about single-cell gene fusion detection is submitted. Applicant: Peking University. Inventors: Ruibin Xi, Zijie Jin. Application number: 202011451710.8. Status of the application: pending. The algorithm developed in this manuscript is covered in the patent application. For all other authors, no competing interests exist.

Footnotes

Publisher’s note Springer Nature remains neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Supplementary information

The online version contains supplementary material available at 10.1038/s41467-022-28661-6.

References

  • 1.Rowley JD. Identificaton of a translocation with quinacrine fluorescence in a patient with acute leukemia. Annal. Genetique. 1973;16:109–112. [PubMed] [Google Scholar]
  • 2.Nowell PC, Hungerford DA. Chromosome studies on normal and leukemic human leukocytes. J. Natl Cancer Inst. 1960;25:85–109. [PubMed] [Google Scholar]
  • 3.Demichelis F, et al. TMPRSS2:ERG gene fusion associated with lethal prostate cancer in a watchful waiting cohort. Oncogene. 2007;26:4596–4599. doi: 10.1038/sj.onc.1210237. [DOI] [PubMed] [Google Scholar]
  • 4.Choi YL, et al. EML4-ALK mutations in lung cancer that confer resistance to ALK inhibitors. N. Engl. J. Med. 2010;363:1734–1739. doi: 10.1056/NEJMoa1007478. [DOI] [PubMed] [Google Scholar]
  • 5.O’Hare T, et al. In vitro activity of Bcr-Abl inhibitors AMN107 and BMS-354825 against clinically relevant imatinib-resistant Abl kinase domain mutants. Cancer Res. 2005;65:4500–4505. doi: 10.1158/0008-5472.CAN-05-0259. [DOI] [PubMed] [Google Scholar]
  • 6.Shaw AT, et al. Crizotinib versus chemotherapy in advanced ALK-positive lung cancer. N. Engl. J. Med. 2013;368:2385–2394. doi: 10.1056/NEJMoa1214886. [DOI] [PubMed] [Google Scholar]
  • 7.Laetsch TW, et al. Larotrectinib for paediatric solid tumours harbouring NTRK gene fusions: phase 1 results from a multicentre, open-label, phase 1/2 study. Lancet Oncol. 2018;19:705–714. doi: 10.1016/S1470-2045(18)30119-0. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 8.Picelli S, et al. Smart-seq2 for sensitive full-length transcriptome profiling in single cells. Nat. Methods. 2013;10:1096–1098. doi: 10.1038/nmeth.2639. [DOI] [PubMed] [Google Scholar]
  • 9.Picelli S, et al. Full-length RNA-seq from single cells using Smart-seq2. Nat. Protoc. 2014;9:171–181. doi: 10.1038/nprot.2014.006. [DOI] [PubMed] [Google Scholar]
  • 10.Ramskold D, et al. Full-length mRNA-Seq from single-cell levels of RNA and individual circulating tumor cells. Nat. Biotechnol. 2012;30:777–782. doi: 10.1038/nbt.2282. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 11.Kharchenko PV. The triumphs and limitations of computational methods for scRNA-seq. Nat. Methods. 2021;18:723–732. doi: 10.1038/s41592-021-01171-x. [DOI] [PubMed] [Google Scholar]
  • 12.Chen K, et al. BreakFusion: targeted assembly-based identification of gene fusions in whole transcriptome paired-end sequencing data. Bioinformatics. 2012;28:1923–1924. doi: 10.1093/bioinformatics/bts272. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 13.Nicorici, D. et al. FusionCatcher—a tool for finding somatic fusion genes in paired-end RNA-sequencing data. BioRxiv10.1101/011650 (2014).
  • 14.Davidson NM, Majewski IJ, Oshlack A. JAFFA: High sensitivity transcriptome-focused fusion gene detection. Genome Med. 2015;7:43. doi: 10.1186/s13073-015-0167-x. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 15.Francis RW, et al. FusionFinder: a software tool to identify expressed gene fusion candidates from RNA-Seq data. PLoS ONE. 2012;7:e39987. doi: 10.1371/journal.pone.0039987. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 16.Li Y, Chien J, Smith DI, Ma J. FusionHunter: identifying fusion transcripts in cancer using paired-end RNA-seq. Bioinformatics. 2011;27:1708–1710. doi: 10.1093/bioinformatics/btr265. [DOI] [PubMed] [Google Scholar]
  • 17.McPherson A, et al. deFuse: an algorithm for gene fusion discovery in tumor RNA-Seq data. PLoS Comput. Biol. 2011;7:e1001138. doi: 10.1371/journal.pcbi.1001138. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 18.Benelli M, et al. Discovering chimeric transcripts in paired-end RNA-seq data by using EricScript. Bioinformatics. 2012;28:3232–3239. doi: 10.1093/bioinformatics/bts617. [DOI] [PubMed] [Google Scholar]
  • 19.Uhrig S, et al. Accurate and efficient detection of gene fusions from RNA sequencing data. Genome Res. 2021;31:448–460. doi: 10.1101/gr.257246.119. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 20.Haas BJ, et al. 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]
  • 21.Dobin A, et al. STAR: ultrafast universal RNA-seq aligner. Bioinformatics. 2013;29:15–21. doi: 10.1093/bioinformatics/bts635. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 22.Ashurst JL, et al. The vertebrate genome annotation (Vega) database. Nucleic Acids Res. 2005;33:D459–D465. doi: 10.1093/nar/gki135. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 23.Zhang Q, et al. Landscape and dynamics of single immune. Cells Hepatocell. Carcinoma Cell. 2019;179:829–845.e820. doi: 10.1016/j.cell.2019.10.003. [DOI] [PubMed] [Google Scholar]
  • 24.Sun T, Song D, Li WV, Li J. J. scDesign2: a transparent simulator that generates high-fidelity single-cell gene expression count data with gene correlations captured. Genome Biol. 2021;22:1–37. doi: 10.1186/s13059-021-02367-2. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 25.Risso D, Perraudeau F, Gribkova S, Dudoit S, Vert JP. A general and flexible method for signal extraction from single-cell RNA-seq data. Nat. Commun. 2018;9:284. doi: 10.1038/s41467-017-02554-5. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 26.Townes FW, Hicks SC, Aryee MJ, Irizarry RA. Feature selection and dimension reduction for single-cell RNA-Seq based on a multinomial model. Genome Biol. 2019;20:1–16. doi: 10.1186/s13059-019-1861-6. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 27.Sarkar A, Stephens M. Separating measurement and expression models clarifies confusion in single-cell RNA sequencing analysis. Nat. Genet. 2021;53:770–777. doi: 10.1038/s41588-021-00873-4. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 28.Schuster M, Paliwal KK. Bidirectional recurrent neural networks. IEEE Trans. Signal Process. 1997;45:2673–2681. [Google Scholar]
  • 29.Quang D, Xie X. DanQ: a hybrid convolutional and recurrent deep neural network for quantifying the function of DNA sequences. Nucleic Acids Res. 2016;44:e107–e107. doi: 10.1093/nar/gkw226. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 30.Yang L, et al. Single-cell RNA-seq of esophageal squamous cell carcinoma cell line with fractionated irradiation reveals radioresistant gene expression patterns. BMC Genomics. 2019;20:611. doi: 10.1186/s12864-019-5970-0. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 31.Horning AM, et al. Single-Cell RNA-seq reveals a subpopulation of prostate cancer cells with enhanced cell-Cycle–Related transcription and attenuated androgen response. Cancer Res. 2018;78:853–864. doi: 10.1158/0008-5472.CAN-17-1924. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 32.Fan J, et al. Linking transcriptional and genetic tumor heterogeneity through allele analysis of single-cell RNA-seq data. Genome Res. 2018;28:1217–1227. doi: 10.1101/gr.228080.117. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 33.Jang JS, et al. Molecular signatures of multiple myeloma progression through single cell RNA-Seq. Blood Cancer J. 2019;9:2. doi: 10.1038/s41408-018-0160-x. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 34.Krivtsov AV, et al. A menin-MLL inhibitor induces specific chromatin changes and eradicates disease in models of MLL-rearranged leukemia. Cancer Cell. 2019;36:660–673. e611. doi: 10.1016/j.ccell.2019.11.001. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 35.Calabrese C, et al. Genomic basis for RNA alterations in cancer. Nature. 2020;578:129–136. doi: 10.1038/s41586-020-1970-0. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 36.Campbell PJ, et al. Pan-cancer analysis of whole genomes. Nature. 2020;578:82–93. doi: 10.1038/s41586-020-1969-6. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 37.Haas BJ, et al. Chimeric 16S rRNA sequence formation and detection in Sanger and 454-pyrosequenced PCR amplicons. Genome Res. 2011;21:494–504. doi: 10.1101/gr.112730.110. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 38.He MX, et al. Transcriptional mediators of treatment resistance in lethal prostate cancer. Nat. Med. 2021;27:426–433. doi: 10.1038/s41591-021-01244-6. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 39.Zheng C, et al. Landscape of infiltrating T cells in liver cancer revealed by single-cell sequencing. Cell. 2017;169:1342–1356 e1316. doi: 10.1016/j.cell.2017.05.035. [DOI] [PubMed] [Google Scholar]
  • 40.Rudak, P. T., Yao, T., Richardson, C. D. & Haeryfar, S. Measles virus infects and programs MAIT cells for apoptosis. J. Infect. Dis.223, 667–672 (2020). [DOI] [PMC free article] [PubMed]
  • 41.Godfrey DI, Koay H-F, McCluskey J, Gherardin NA. The biology and functional importance of MAIT cells. Nat. Immunol. 2019;20:1110–1128. doi: 10.1038/s41590-019-0444-8. [DOI] [PubMed] [Google Scholar]
  • 42.Barwick BG, et al. Multiple myeloma immunoglobulin lambda translocations portend poor prognosis. Nat. Commun. 2019;10:1911. doi: 10.1038/s41467-019-09555-6. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 43.Bergsagel PL, et al. Promiscuous translocations into immunoglobulin heavy chain switch regions in multiple myeloma. Proc. Natl Acad. Sci. USA. 1996;93:13931–13936. doi: 10.1073/pnas.93.24.13931. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 44.Forbes SA, et al. COSMIC: exploring the world’s knowledge of somatic mutations in human cancer. Nucleic Acids Res. 2015;43:D805–D811. doi: 10.1093/nar/gku1075. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 45.Stec I, et al. WHSC1, a 90 kb SET domain-containing gene, expressed in early development and homologous to a Drosophila dysmorphy gene maps in the Wolf-Hirschhorn syndrome critical region and is fused to IgH in t (1; 14) multiple myeloma. Hum. Mol. Genet. 1998;7:1071–1082. doi: 10.1093/hmg/7.7.1071. [DOI] [PubMed] [Google Scholar]
  • 46.Santra M, Zhan F, Tian E, Barlogie B, Shaughnessy J., Jr A subset of multiple myeloma harboring the t (4; 14)(p16; q32) translocation lacks FGFR3 expression but maintains an IGH/MMSET fusion transcript. Blood J. Am. Soc. Hematol. 2003;101:2374–2376. doi: 10.1182/blood-2002-09-2801. [DOI] [PubMed] [Google Scholar]
  • 47.Malgeri U, et al. Detection of t (4; 14)(p16. 3; q32) chromosomal translocation in multiple myeloma by reverse transcription-polymerase chain reaction analysis of IGH-MMSET fusion transcripts. Cancer Res. 2000;60:4058–4061. [PubMed] [Google Scholar]
  • 48.Kuo AJ, et al. NSD2 links dimethylation of histone H3 at lysine 36 to oncogenic programming. Mol. Cell. 2011;44:609–620. doi: 10.1016/j.molcel.2011.08.042. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 49.Keats JJ, Reiman T, Belch AR, Pilarski LM. Ten years and counting: so what do we know about t(4;14)(p16;q32) multiple myeloma. Leuk. Lymphoma. 2006;47:2289–2300. doi: 10.1080/10428190600822128. [DOI] [PubMed] [Google Scholar]
  • 50.Mahajan N, Weber JD, Maggi LB, Tomasson MH. ACA11, a small nucleolar RNA activated in multiple myeloma, stimulates proliferation by inactivating NRF2 and increasing redox signaling. FASEB J. 2016;30:1054.1057–1054.1057. [Google Scholar]
  • 51.Mani R-S, et al. TMPRSS2–ERG-mediated feed-forward regulation of wild-type ERG in human prostate cancers. Cancer Res. 2011;71:5387–5392. doi: 10.1158/0008-5472.CAN-11-0876. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 52.Adamo P, Ladomery MR. The oncogene ERG: a key factor in prostate cancer. Oncogene. 2016;35:403–414. doi: 10.1038/onc.2015.109. [DOI] [PubMed] [Google Scholar]
  • 53.Semaan L, Mander N, Cher ML, Chinni SR. TMPRSS2-ERG fusions confer efficacy of enzalutamide in an in vivo bone tumor growth model. BMC Cancer. 2019;19:972. doi: 10.1186/s12885-019-6185-0. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 54.Zimmermann S, et al. ALPK1- and TIFA-dependent innate immune response triggered by the Helicobacter pylori type IV secretion system. Cell Rep. 2017;20:2384–2395. doi: 10.1016/j.celrep.2017.08.039. [DOI] [PubMed] [Google Scholar]
  • 55.Keats JJ, et al. Overexpression of transcripts originating from the MMSET locus characterizes all t(4;14)(p16;q32)-positive multiple myeloma patients. Blood. 2005;105:4060–4069. doi: 10.1182/blood-2004-09-3704. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 56.Sims D, Sudbery I, Ilott NE, Heger A, Ponting CP. Sequencing depth and coverage: key considerations in genomic analyses. Nat. Rev. Genet. 2014;15:121–132. doi: 10.1038/nrg3642. [DOI] [PubMed] [Google Scholar]
  • 57.Kingma, D. P. & Ba, J. L. Adam: a method for stochastic optimization. 3rd Int. Conf. Learn. Represent. ICLR 2015 - Conf. Track Proc. 1–15 (2015).
  • 58.Alipanahi B, Delong A, Weirauch MT, Frey BJ. Predicting the sequence specificities of DNA- and RNA-binding proteins by deep learning. Nat. Biotechnol. 2015;33:831–838. doi: 10.1038/nbt.3300. [DOI] [PubMed] [Google Scholar]
  • 59.Butler A, Hoffman P, Smibert P, Papalexi E, Satija R. Integrating single-cell transcriptomic data across different conditions, technologies, and species. Nat. Biotechnol. 2018;36:411–420. doi: 10.1038/nbt.4096. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 60.Stuart T, et al. Comprehensive Integration of Single- Cell Data. Cell. 2019;177:1888–1902.e1821. doi: 10.1016/j.cell.2019.05.031. [DOI] [PMC free article] [PubMed] [Google Scholar]
  • 61.Jin, Z. et al. Single cell gene fusion detection by scFusion. GitHub10.5281/zenodo.5879110 (2022) [DOI] [PMC free article] [PubMed]

Associated Data

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

Supplementary Materials

Reporting Summary (363.8KB, pdf)
Peer Review File (4.8MB, pdf)
41467_2022_28661_MOESM4_ESM.pdf (68KB, pdf)

Description of Additional Supplementary Files

Supplementary Data 1 (13.7KB, xlsx)
Supplementary Data 2 (79.5KB, xlsx)
Supplementary Data 3 (97.3KB, xlsx)
Supplementary Data 4 (87.4KB, xlsx)
Supplementary Data 5 (115.3KB, xlsx)
Supplementary Data 6 (97.2KB, xlsx)
Supplementary Data 7 (10.1KB, xlsx)
Supplementary Data 8 (26.8KB, xlsx)
Supplementary Data 9 (51.2KB, xlsx)
Supplementary Data 10 (121.3KB, xlsx)
Supplementary Data 11 (1MB, xlsx)
Supplementary Data 12 (45.8KB, xlsx)
Supplementary Data 13 (13.6KB, xlsx)
Supplementary Data 14 (16.8KB, xlsx)
Supplementary Data 15 (37.3KB, xlsx)
Supplementary Data 16 (333.5KB, xlsx)
Supplementary Data 17 (13.9KB, xlsx)
Supplementary Data 18 (22.2KB, xlsx)
Supplementary Data 19 (12.8KB, xlsx)
Supplementary Data 20 (15.9KB, xlsx)
Supplementary Data 21 (156.5KB, xlsx)
Supplementary Data 22 (17.1KB, xlsx)
Supplementary Data 23 (16.5KB, xlsx)
Supplementary Data 24 (10.2KB, xlsx)
Supplementary Data 25 (10.2KB, xlsx)
Supplementary Data 26 (40.5KB, xlsx)
Supplementary Data 27 (15.1KB, xlsx)
Supplementary Data 28 (12.5KB, xlsx)
Supplementary Data 29 (18.8KB, xlsx)
Supplementary Data 30 (16.8KB, xlsx)
Supplementary Data 31 (22KB, xlsx)
Supplementary Data 32 (11.9KB, xlsx)
Supplementary Data 33 (11.3KB, xlsx)
Supplementary Data 34 (14KB, xlsx)

Data Availability Statement

Raw data of the spike-in data generated in this study have been deposited in the Genome Sequence Archive (GSA) of BIG Data Center, Beijing Institute of Genomics (BIG), Chinese Academy of Sciences, with an accession code HRA001199. The scRNA-seq data used in this study are available in Gene Expression Omnibus (GEO) under accession code GSE81812, GSE99795, GSE110499, GSE118900, GSE127298, GSE140228. Raw sequence data of the prostate patient data used in this study are available in dbGaP under accession codephs001988.v1.p1 (https://www.ncbi.nlm.nih.gov/projects/gap/cgi-bin/study.cgi?study_id=phs001988.v1.p1). Source data are provided with this paper.

scFusion is available at GitHub (https://github.com/XiDsLab/scFusion)61.


Articles from Nature Communications are provided here courtesy of Nature Publishing Group

RESOURCES