Next Article in Journal
Skeletal Muscle–Adipose Tissue–Tumor Axis: Molecular Mechanisms Linking Exercise Training in Prostate Cancer
Next Article in Special Issue
Rapidly Growing Protein-Centric Technologies to Extensively Identify Protein–RNA Interactions: Application to the Analysis of Co-Transcriptional RNA Processing
Previous Article in Journal
Beyond Dopamine Receptor Antagonism: New Targets for Schizophrenia Treatment and Prevention
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

AS-Quant: Detection and Visualization of Alternative Splicing Events with RNA-seq Data

1
Department of Computer Science, University of Central Florida, Orlando, FL 32816, USA
2
Genomics and Bioinformatics Cluster, University of Central Florida, Orlando, FL 32816, USA
3
Department of Electrical and Computer Engineering, University of Central Florida, Orlando, FL 32816, USA
4
Department of Biochemistry, Molecular Biology and Biophysics, University of Minnesota Twin Cities, Minneapolis, MN 55455, USA
5
School of Electrical, Computer and Energy Engineering, Arizona State University, Tempe, AZ 85287, USA
*
Authors to whom correspondence should be addressed.
Int. J. Mol. Sci. 2021, 22(9), 4468; https://0-doi-org.brum.beds.ac.uk/10.3390/ijms22094468
Submission received: 19 March 2021 / Revised: 19 April 2021 / Accepted: 22 April 2021 / Published: 25 April 2021
(This article belongs to the Special Issue Splicing Modulators Which Affect Gene Expression)

Abstract

:
(1) Background: A simplistic understanding of the central dogma falls short in correlating the number of genes in the genome to the number of proteins in the proteome. Post-transcriptional alternative splicing contributes to the complexity of the proteome and is critical in understanding gene expression. mRNA-sequencing (RNA-seq) has been widely used to study the transcriptome and provides opportunity to detect alternative splicing events among different biological conditions. Despite the popularity of studying transcriptome variants with RNA-seq, few efficient and user-friendly bioinformatics tools have been developed for the genome-wide detection and visualization of alternative splicing events. (2) Results: We propose AS-Quant, (Alternative Splicing Quantitation), a robust program to identify alternative splicing events from RNA-seq data. We then extended AS-Quant to visualize the splicing events with short-read coverage plots along with complete gene annotation. The tool works in three major steps: (i) calculate the read coverage of the potential spliced exons and the corresponding gene; (ii) categorize the events into five different categories according to the annotation, and assess the significance of the events between two biological conditions; (iii) generate the short reads coverage plot for user specified splicing events. Our extensive experiments on simulated and real datasets demonstrate that AS-Quant outperforms the other three widely used baselines, SUPPA2, rMATS, and diffSplice for detecting alternative splicing events. Moreover, the significant alternative splicing events identified by AS-Quant between two biological contexts were validated by RT-PCR experiment. (3) Availability: AS-Quant is implemented in Python 3.0. Source code and a comprehensive user’s manual are freely available online.

1. Introduction

A single gene can contain multiple exons and introns in eukaryotes. Exons can be joined together by splicing in different ways. Recent studies have estimated that alternative splicing events exist in more than 95% of multi-exon genes in human and mouse [1,2,3], and it provides cells with the opportunity to create protein isoforms with multiple functions from a single gene. Alternative splicing is a central element in gene expression. It influences almost all aspects of protein functions, including binding between proteins and ligand, nucleic acids or membranes, localization and enzymatic properties [2]. Alternative splicing events are generally regulated by dynamic reorganization and binding of splicing factors to c i s -sequences elements in pre-mRNA, and occurs in various fashions [1]. Figure 1 lists five major types of alternative splicing events [4] found in eukaryotes. They are: Skipped Exon (SE), Retained Intron (RI), Alternative 3’ Splice Site (A3SS), Alternative 5’ Splice Site (A5SS), and Mutually Exclusive Exon (MXE).
A precise detection of alternative splicing events among different biological contexts could provide insights into new molecular mechanisms and define high-resolution molecular signatures for phenotype predictions [5,6]. High-throughput RNA-seq platform is capable of studying splicing variants, and several bioinformatics tools have been developed to identify alternative splicing events with RNA-seq [4,7,8,9,10]. However, the selection for comprehensive and genome-wide assessments of the splicing events is limited, and few of the existing tools can provide high-resolution read coverage plots of the splicing events with accurate isoform annotation. We have developed AS-Quant, a program for genome-wide alternative splicing events detection and visualization. It efficiently handles large-scale alignment files with hundreds of millions of reads in different biological contexts and generates a comprehensive report for most, if not all, potential alternative splicing events (both annotated and unannotated), and also generates high quality plots for the splicing events.

2. Results

In the experiments, AS-Quant was compared with three widely used alternative splicing events detection pipelines, SUPPA2 [9], rMATS [8], and diffSplice [7] on both simulated and real RNA-seq datasets. In the simulation experiment, flux-simulator [11] was applied to generate synthetic RNA-seq data with true alternative splicing events between different samples. In the real RNA-seq experiment on mouse embryonic fibroblast (MEF) cell lines, the detected alternative splicing events were validated by RT-PCR experiment.

2.1. Experimental Results with Simulated RNA-seq Data

In the simulations, we applied flux-simulator [11] to generate paired-end short reads to simulate RNA-seq experiment in silico based on a ground truth transcript expression profile and list of alternative splicing events between two conditions, using mm10 reference mouse genome with UCSC annotation. 1565 alternative splicing events, separated in five categories (Figure 1) were generated between two conditions. For each condition, three replicates were created by repeating the whole experiment with the same parameter settings in the flux-simulator to represent the samples in two different biological conditions. The flux-simulator parameters used in this experiment are listed in the Supplementary document. To generate the ground truth expression profile and the alternative splicing events, the gene expressions were sampled from a Poisson distribution to reflect real RNA-seq data [12]. For the genes with true splicing events, the transcripts in the gene were separated into two groups, one with spliced exon and one without spliced exon (for the genes with MXE event, the transcript(s) in each group contain one spliced exon). The expression proportions of the two groups in the same gene are set significantly different for the two conditions (i.e., the proportion difference was larger than 10%) to support the presence of altered exons. Whereas, for the gene without splicing events, the transcript expressions in the two conditions are kept similar to each other. In such way, we simulated 766, 108, 94, 368, and 229 alternative splicing events for the five categories, SE, MXE, RI, A3SS, and A5SS, respectively.
In the simulation experiment, 50 million paired-end reads with 76 bps of each end were generated for each replicate in each condition by flux-simulator. AS-Quant was compared with SUPPA2, rMATS, and diffSplice on the simulated RNA-seq data. The area under the ROC curve (AUC), sensitivity (true positive rate), and specificity (true negative rate) were calculated to evaluate the performance of AS-Quant and baseline methods. From the results reported in Table 1 and the ROC curves in Figure 2, we observed that AS-Quant has the best overall performance (AUC = 0.84) followed by SUPPA2 (AUC = 0.80) and diffSplice (AUC = 0.74). rMATS (AUC = 0.65) did not work very well compared to the other three methods due to a large number of false positive events. In addition, we also report the performance of the four methods on each type of alternative splicing events in Table 2 and the ROC curves in Figures S1–S5 in the Supplementary document. AS-Quant got the highest AUC scores in four out of five types. In three out of five categories (i.e., SE, MXE, A3SS), the AUC scores for AS-Quant were close to 1, which indicates that our pipeline can almost perfectly detect these three types of events in the simulated RNA-seq data. SUPPA2 requires the transcript quantification results from a RNA-seq quantification method (e.g., Salmon [13]) as its input, and its performance depends on the quality of the input transcript expressions. In this simulation experiment, SUPPA2 did better than AS-Quant on A5SS. rMATS got the highest sensitivity score on SE since it reported more positive events compared to the other three methods, but the specificity score was much lower than the other methods due to a large number of false ones in its reported events. Both AS-Quant and SUPPA2 got the highest specificity score in three out of five categories and diffSplice got the highest specificity score on MXE. Overall, AS-Quant outperformed SUPPA2, rMATS, and diffSplice on detecting true alternative splicing events in the simulation experiment.
To learn the impact of sequencing depths on analysis of alternative splicing with AS-Quant, we simulated several RNA-seq data with different read depths, i.e., 1 M (million), 2 M, 5 M, 10 M, 30 M, and 50 M paired-end reads by flux-simulator with the same parameter setting and ran AS-Quant on each experiment separately. In each experiment, three replicates were generated in each condition and the same 1565 alternative splicing events were generated as a ground truth between two conditions using the same procedures as mentioned in the previous section. The ROC curves for different read depth are shown in Figure 3. We observed that after the sequencing depth reached 5 million, the performance of AS-Quant are almost same. The result suggests that AS-Quant is relative robust for alternative splicing events detection on low read coverage samples and lowly expressed genes.

2.2. Experimental Results with Mouse Embryonic Fibroblasts (MEFs) Samples

To evaluate the performance of AS-Quant on the real RNA-seq data, two MEFs samples, T s c 1 / MEFs with control and U2af1 knocked down (siU2af1) were used in the analysis (SRP215854). U2af1 is a splicing factor and plays a role in alternative splicing [14]. In total, 81,677,330 paired-end reads for T s c 1 / control and 87,017,091 paired-end reads for siU2af1 were produced from Hi-Seq pipeline with length of 51 bp of each end. The raw RNA-seq fastq files were aligned to mouse mm10 reference genome using TopHat2 [15]. AS-Quant was then applied to detect significant alternative splicing events between the two samples with p-value < 0.05 and absolute ratio difference between the two samples > 0.1 (Equation (2)). AS-Quant detected 257, 5, 43, 101, and 30 events for SE, RI, MXE, A3SS, and A5SS, respectively. The three baseline methods, SUPPA2, rMATS, and diffSplice, were also applied on the two samples. The splicing events identified by SUPPA2 were specified based on the difference of relative abundances between two conditions, called percent spliced-in (PSI) value > 0.2 and p-value < 0.05. The significant events reported by rMATS were selected based on the two thresholds, | Δ Ψ | > 5% ( Ψ is the exon inclusion level) and false discovery rate (FDR) ≤ 1% [8], whereas the significant events identified by diffSplice were determined by the square root of the Jensen–Shannon divergence (JSD) > 0.2 [7]. Table 3 shows the number of events detected by the four methods in the five splicing categories.
Based on the potential events reported by AS-Quant, four genes, Ptbp1, Ganab, Camk2g and Tpm3, were selected for validation. These genes were selected due the design of PCR (polymerase chain reaction) primers for wet-lab validation. The alternative splicing events in Ptbp1 and Ganab were also identified by SUPPA2, rMATS, and diffSplice, whereas the event in Camk2g was only identified by AS-Quant and the event in Tpm3 was only identified by AS-Quant and SUPPA2. Figure 4a represents the two read coverage plots for Ptbp1 and Ganab, and Figure 5a shows the read coverage plots for Camk2g and Tpm3. The alternative spliced exons are marked in yellow in the plots. RT (reverse transcription)-PCR and agarose gel electrophoresis were applied to validate the expression of the transcript isoforms with exon inclusion/exclusion. As shown in Figure 4b and Figure 5b, exon inclusion and exclusion between the two samples show significant changes, which is consistent with our observations on the RNA-seq read coverage plots reported in Figure 4a and Figure 5a. These results further confirmed that AS-Quant can identify not only the true alternative splicing events which can be detected by the baseline methods, but also the true events which are ignored by the baseline methods in the RNA-seq samples from two different biological contexts.

3. Discussion

The eukaryotic genome is capable of producing multiple isoforms from a gene by alternative splicing during pre-mRNA processing. It provides cells with the opportunity to create protein isoforms from the same gene to participate in different functional pathways. Therefore, accurately profiling transcript variants between different biological states could lead to the finding of new molecular mechanisms and potentially better molecular signals for phenotype predictions. However, the options for comprehensive and genome-scale assessment of the alternative splicing events are limited due to the low-resolution analyzing power. In this study we developed a novel and user-friendly pipeline, AS-Quant, to detect five different types of alternative splicing events between two biological contexts and provide high-resolution read coverage plots with annotation for user specified splicing events. The pipeline not only can accurately detect the splicing events compare to the baseline methods, but also provide reasonable running time. AS-Quant took 41 CPU minutes to run the experiments on the two MEFs samples, whereas SUPPA2, rMATS, and diffSplice took 29, 93, and 32 CPU minutes, respectively. The CPU time was measured on Intel(R) Xeon(R) CPU E5-2620 v4 @ 2.10 GHz. Although AS-Quant relies on current annotation, it can also detect unannotated SE event (Figure S6 in the Supplementary document). Our pipeline will be further improved to do d e n o v o analysis for all five types of splicing events in future studies. Overall, this study reports an efficient and precise framework for isoform detection in the transcriptomic data.

4. Materials and Methods

AS-Quant workflow consists of three steps: (i) read coverage estimation of exons; (ii) alternative splicing events categorization and assessment; (iii) visualization of splicing events (Figure 6).
The first step requires aligned RNA-seq data of two different biological conditions in BAM format as the input. Each biological condition can contain multiple samples in each group. The read coverage files are generated from the annotated genes and exons for each sample with SAMtools [16]. In the second step, AS-Quant first identifies all potential alternative splicing events of five different categories (Figure 1) based on UCSC gene annotation following the lead of the study in [4] and the unannotated skipped exon (SE) events. The alternative splicing exon in each category is highlighted in yellow in the middle panel of Figure 6. For each spliced exon of each category, the average read coverage (n) is then computed by estimating the number of reads mapped to that exon ( r e ) divided by its effective length ( l e ).
n = r e l e
The average read coverage (N) for all other exons in that specific gene is calculated the same way, by dividing the number of mapped reads ( R e ¯ ) to all these exons by their summed length ( L e ¯ ). Next, the ratio differences between the two conditions are calculated based on the following equation:
n 1 N 1 n 2 N 2 ,
where 1 and 2 represent the two conditions. A large positive ratio difference indicates a potential splicing event in condition 2, whereas a negative ratio difference with a large absolute value indicates a potential splicing event in condition 1. After that, a canonical 2 × 2 χ 2 -test is applied to report a p-value for each potential splicing event. If there is more than one sample or replicate under each condition, the Wilcoxon rank-sum test can be applied to determine the events. Only the events which show a significant p-value (<0.05) among the two conditions and a absolute ratio difference larger than a threshold (>0.1) will be reported.
Based on the significant splicing events reported in the second step, AS-Quant generates RNA-seq read coverage plots along with the gene’s annotation in the third step. For any user-specific input with chromosome and genomic coordinates (chr:start_position-end_position), AS-Quant illustrates the event with a high quality read coverage plot for a better illustration of the process. The bottom panel in Figure 6 shows an example of the read coverage plot generated from AS-Quant. Figure S7 in the Supplementary document shows an example of the retained intron (RI) event detected by AS-Quant.
In this study, the area under the ROC curve (AUC), sensitivity (true positive rate) and specificity (true negative rate) were applied to evaluate the performance of AS-Quant and baseline methods. An ROC curve plots true positive rate and false positive rate at different classification thresholds and AUC provides an aggregate measure of performance across these classification thresholds. Sensitivity and specificity are defined as follows
S e n s i t i v i t y = T P T P   +   F N
S p e c i f i c i t y = T N T N   +   F P
where TP, TN, FP, and FN denote the number of true positives, true negatives, false positives, and false negatives, respectively. Three widely used alternative splicing events’ detection pipelines, SUPPA2 [9], rMATS [8], and diffSplice [7] were applied to compare the performance with AS-Quant. The command lines for running SUPPA2, rMATS, and diffSplice are available in the Supplementary document.

5. Conclusions

We present AS-Quant, a computational pipeline that allows the identification of transcriptome-wide alternative splicing events in RNA-seq data. The significant events are illustrated by read coverage plots along with full annotations of a specific gene. The experimental results on two mouse MEFs samples by RT-PCR and simulated RNA-seq data demonstrate that AS-Quant is an accurate and efficient tool to detect alternative splicing events between samples with different biological contexts.

Supplementary Materials

The following are available online at https://0-www-mdpi-com.brum.beds.ac.uk/article/10.3390/ijms22094468/s1, Figures S1–S5: Simulation experiment (50 M reads) to assess the performance of AS-Quant and baseline methods to detect SE, RI, MXE, A3SS, and A5SS events, respectively, Figure S6: Novel AS event in SRRM1 identified by AS-Quant, Figure S7: Intron Retention (RI) event in gene Rbm10 identified and plotted by AS-Quant, AS-Quant user manual.

Author Contributions

Conceptualization, W.Z. and J.Y.; methodology, N.A.F., W.Z., H.N., D.F. and J.S.; software, N.A.F.; validation, J.C., M.P., H.Y., and J.Y.; formal analysis, N.A.F.; investigation, N.A.F. and H.N.; resources, J.Y.; data curation, N.A.F.; writing—original draft preparation, W.Z., N.A.F., H.Y. and J.Y.; writing—review and editing, W.Z., N.A.F., J.S., and J.Y.; supervision, W.Z. and J.Y.; funding acquisition, W.Z., J.Y. and D.F. All authors have read and agreed to the published version of the manuscript.

Funding

The research works are supported by grant from the National Science Foundation [IIS 1755761 and FET 1908495] and National Institutes of Health [2R01GM113952].

Institutional Review Board Statement

Not applicable.

Informed Consent Statement

Not applicable.

Data Availability Statement

Source code and a comprehensive user’s manual are freely available at https://github.com/CompbioLabUCF/AS-Quant (accessed on 23 April 2021). The mouse cell line data is available at SRP215854 (accessed on 23 April 2021).

Conflicts of Interest

The authors declare no conflict of interest.

Abbreviations

The following abbreviations are used in this manuscript:
AS-QuantAlternative Splicing Q u a n t itation
RT-PCRReverse Transcription Polymerase Chain Reaction
MEFsMouse Embryonic Fibroblasts
FDRFalse Discovery Rate
JSDJensen–Shannon Divergence
SESkipped Exon
MXEMutually Exclusive Exon
RIRetained Intron
A5SSAlternative 5’ Splice Site
A3SSAlternative 3’ Splice Site

References

  1. Zhiguo, E.; Wang, L.; Zhou, J. Splicing and alternative splicing in rice and humans. BMB Rep. 2013, 46, 439. [Google Scholar]
  2. Wang, Y.; Liu, J.; Huang, B.; Xu, Y.M.; Li, J.; Huang, L.F.; Lin, J.; Zhang, J.; Min, Q.H.; Yang, W.M.; et al. Mechanism of alternative splicing and its regulation. Biomed. Rep. 2015, 3, 152–158. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  3. Chang, J.W.; Yeh, H.S.; Park, M.; Erber, L.; Sun, J.; Cheng, S.; Bui, A.M.; Fahmi, N.A.; Nasti, R.; Kuang, R.; et al. mTOR-regulated U2af1 tandem exon splicing specifies transcriptome features for translational control. Nucleic Acids Res. 2019, 47, 10373–10387. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  4. Shen, S.; Park, J.W.; Huang, J.; Dittmar, K.A.; Lu, Z.X.; Zhou, Q.; Carstens, R.P.; Xing, Y. MATS: A Bayesian framework for flexible detection of differential alternative splicing from RNA-Seq data. Nucleic Acids Res. 2012, 40, e61. [Google Scholar] [CrossRef] [PubMed]
  5. Zhang, W.; Chang, J.W.; Lin, L.; Minn, K.; Wu, B.; Chien, J.; Yong, J.; Zheng, H.; Kuang, R. Network-based isoform quantification with RNA-seq data for cancer transcriptome analysis. PLoS Comput. Biol. 2015, 11, e1004465. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  6. Sun, J.; Chang, J.W.; Zhang, T.; Yong, J.; Kuang, R.; Zhang, W. Platform-integrated mRNA Isoform Quantification. Bioinformatics 2020, 36, 2466–2473. [Google Scholar] [CrossRef] [PubMed]
  7. Hu, Y.; Huang, Y.; Du, Y.; Orellana, C.F.; Singh, D.; Johnson, A.R.; Monroy, A.; Kuan, P.F.; Hammond, S.M.; Makowski, L.; et al. DiffSplice: The genome-wide detection of differential splicing events with RNA-seq. Nucleic Acids Res. 2013, 41, e39. [Google Scholar] [CrossRef] [PubMed]
  8. Shen, S.; Park, J.W.; Lu, Z.X.; Lin, L.; Henry, M.D.; Wu, Y.N.; Zhou, Q.; Xing, Y. rMATS: Robust and flexible detection of differential alternative splicing from replicate RNA-Seq data. Proc. Natl. Acad. Sci. USA 2014, 111, E5593–E5601. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  9. Trincado, J.L.; Entizne, J.C.; Hysenaj, G.; Singh, B.; Skalic, M.; Elliott, D.J.; Eyras, E. SUPPA2: Fast, accurate, and uncertainty-aware differential splicing analysis across multiple conditions. Genome Biol. 2018, 19, 1–11. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  10. Zhang, Z.; Pan, Z.; Ying, Y.; Xie, Z.; Adhikari, S.; Phillips, J.; Carstens, R.P.; Black, D.L.; Wu, Y.; Xing, Y. Deep-learning augmented RNA-seq analysis of transcript splicing. Nat. Methods 2019, 16, 307. [Google Scholar] [CrossRef] [PubMed]
  11. Griebel, T.; Zacher, B.; Ribeca, P.; Raineri, E.; Lacroix, V.; Guigó, R.; Sammeth, M. Modelling and simulating generic RNA-Seq experiments with the flux simulator. Nucleic Acids Res. 2012, 40, 10073–10083. [Google Scholar] [CrossRef] [PubMed]
  12. Oshlack, A.; Robinson, M.D.; Young, M.D. From RNA-seq reads to differential expression results. Genome Biol. 2010, 11, 220. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  13. Patro, R.; Duggal, G.; Love, M.I.; Irizarry, R.A.; Kingsford, C. Salmon provides fast and bias-aware quantification of transcript expression. Nat. Methods 2017, 14, 417–419. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  14. Mollet, I.; Barbosa-Morais, N.L.; Andrade, J.; Carmo-Fonseca, M. Diversity of human U2AF splicing factors: Based on the EMBO Lecture delivered on 7 July 2005 at the 30th FEBS Congress in Budapest. FEBS J. 2006, 273, 4807–4816. [Google Scholar] [CrossRef] [PubMed]
  15. Kim, D.; Pertea, G.; Trapnell, C.; Pimentel, H.; Kelley, R.; Salzberg, S.L. TopHat2: Accurate alignment of transcriptomes in the presence of insertions, deletions and gene fusions. Genome Biol. 2013, 14, 1–13. [Google Scholar] [CrossRef] [PubMed] [Green Version]
  16. Li, H.; Handsaker, B.; Wysoker, A.; Fennell, T.; Ruan, J.; Homer, N.; Marth, G.; Abecasis, G.; Durbin, R. The sequence alignment/map format and SAMtools. Bioinformatics 2009, 25, 2078–2079. [Google Scholar] [CrossRef] [PubMed] [Green Version]
Figure 1. Five major types of alternative splicing events. The alternative splicing exon(s) in each category is highlighted in yellow.
Figure 1. Five major types of alternative splicing events. The alternative splicing exon(s) in each category is highlighted in yellow.
Ijms 22 04468 g001
Figure 2. Simulation experiment to assess the performance of AS-Quant and baseline methods. The receiver operating characteristic (ROC) curves, i.e., true positive rate against false positive rate, are plotted.
Figure 2. Simulation experiment to assess the performance of AS-Quant and baseline methods. The receiver operating characteristic (ROC) curves, i.e., true positive rate against false positive rate, are plotted.
Ijms 22 04468 g002
Figure 3. Simulation experiment to assess the performance of AS-Quant on different read depths. The ROC curves for the results of different RNA-seq read depth are plotted.
Figure 3. Simulation experiment to assess the performance of AS-Quant on different read depths. The ROC curves for the results of different RNA-seq read depth are plotted.
Ijms 22 04468 g003
Figure 4. Validation of U2AF1-mediated alternative splicing events that are commonly detected by all four tested methods. (a) RNA-seq read coverage plots of the gene Ptbp1 and Ganab in the two samples with accurate isoform annotations. Alternatively spliced exons are marked in yellow. (b) Validation of isoform expression using RT-PCR and agarose gel electrophoresis. Quantitation of gel images was done using ImageQuant software. Exon inclusion and exclusion are color-coded. Total RNAs from T s c 1 / MEFs used for RNA-Seq experiments were used for RT-PCR amplification of Ptbp1 or Ganab transcript isoforms. Scrambled RNA interference is control and U2af1 RNA interference is the case. The PCR primers to detect transcript isoforms for Ptbp1 or Ganab were marked by red arrows and their sequences are reported in the Supplementary document. Schematic of alternative spliced isoform structures for each PCR product is shown next to the gel image. Exon numbers and transcript identification numbers in RefSeq annotation are shown. A higher band intensity of PCR products indicates a higher expression of that specific transcript isoform.
Figure 4. Validation of U2AF1-mediated alternative splicing events that are commonly detected by all four tested methods. (a) RNA-seq read coverage plots of the gene Ptbp1 and Ganab in the two samples with accurate isoform annotations. Alternatively spliced exons are marked in yellow. (b) Validation of isoform expression using RT-PCR and agarose gel electrophoresis. Quantitation of gel images was done using ImageQuant software. Exon inclusion and exclusion are color-coded. Total RNAs from T s c 1 / MEFs used for RNA-Seq experiments were used for RT-PCR amplification of Ptbp1 or Ganab transcript isoforms. Scrambled RNA interference is control and U2af1 RNA interference is the case. The PCR primers to detect transcript isoforms for Ptbp1 or Ganab were marked by red arrows and their sequences are reported in the Supplementary document. Schematic of alternative spliced isoform structures for each PCR product is shown next to the gel image. Exon numbers and transcript identification numbers in RefSeq annotation are shown. A higher band intensity of PCR products indicates a higher expression of that specific transcript isoform.
Ijms 22 04468 g004
Figure 5. Validation of U2AF1-mediated alternative splicing events that are only detected by AS-Quant (Camk2g) or by AS-Quant and SUPPA2 (Tpm3). (a) Isoform structures of Camk2g and Tpm3 gene and their RNA-seq read coverage plots. Alternatively spliced exons are marked in yellow. (b) Validation of isoform expressions was conducted using RT-PCR and agarose gel electrophoresis. Quantitation of gel images was done using ImageQuant software. Two biological repeats of experiment were performed. Exon inclusion and exclusion are color-coded. Total RNAs from T s c 1 / MEFs used for RNA-Seq experiments were used for RT-PCR amplification of Camk2g or Tpm3 transcript isoforms. Scrambled RNA interference is control and U2af1 RNA interference is the case. The PCR primers to detect transcript isoforms for Camk2g or Tpm3 were marked by red arrows and their sequences are reported in the Supplementary document. Schematic of alternative spliced isoform structures for each PCR product is shown next to the gel image. Exon numbers and transcript identification numbers in RefSeq annotation are shown. A higher band intensity of PCR products indicates a higher expression of that specific transcript isoform.
Figure 5. Validation of U2AF1-mediated alternative splicing events that are only detected by AS-Quant (Camk2g) or by AS-Quant and SUPPA2 (Tpm3). (a) Isoform structures of Camk2g and Tpm3 gene and their RNA-seq read coverage plots. Alternatively spliced exons are marked in yellow. (b) Validation of isoform expressions was conducted using RT-PCR and agarose gel electrophoresis. Quantitation of gel images was done using ImageQuant software. Two biological repeats of experiment were performed. Exon inclusion and exclusion are color-coded. Total RNAs from T s c 1 / MEFs used for RNA-Seq experiments were used for RT-PCR amplification of Camk2g or Tpm3 transcript isoforms. Scrambled RNA interference is control and U2af1 RNA interference is the case. The PCR primers to detect transcript isoforms for Camk2g or Tpm3 were marked by red arrows and their sequences are reported in the Supplementary document. Schematic of alternative spliced isoform structures for each PCR product is shown next to the gel image. Exon numbers and transcript identification numbers in RefSeq annotation are shown. A higher band intensity of PCR products indicates a higher expression of that specific transcript isoform.
Ijms 22 04468 g005
Figure 6. Workflow of AS-Quant. Starting with aligned RNA-seq bam files, AS-Quant consists of three steps (i) read coverage estimation, (ii) splicing events categorization and assessment, (iii) visualization.
Figure 6. Workflow of AS-Quant. Starting with aligned RNA-seq bam files, AS-Quant consists of three steps (i) read coverage estimation, (ii) splicing events categorization and assessment, (iii) visualization.
Ijms 22 04468 g006
Table 1. Comparison among AS-Quant, SUPPA2, rMATS and diffSplice on simulated RNA-seq data. AUC score, sensitivity, specificity of the four methods are reported. The best results across the four methods are bold.
Table 1. Comparison among AS-Quant, SUPPA2, rMATS and diffSplice on simulated RNA-seq data. AUC score, sensitivity, specificity of the four methods are reported. The best results across the four methods are bold.
MethodAUCSensitivitySpecificity
AS-Quant0.840.640.98
SUPPA20.800.440.97
rMATS0.650.220.49
diffSplice0.740.050.79
Table 2. Comparison among AS-Quant, SUPPA2, rMATS, and diffSplice on simulated RNA-seq data. AUC score, sensitivity, specificity of the four methods on five different types of splicing events are reported. The best results across the four methods are bold.
Table 2. Comparison among AS-Quant, SUPPA2, rMATS, and diffSplice on simulated RNA-seq data. AUC score, sensitivity, specificity of the four methods on five different types of splicing events are reported. The best results across the four methods are bold.
AS TypeMethodAUCSensitivitySpecificity
AS-Quant0.970.601.00
SESUPPA20.840.640.99
rMATS0.840.800.50
diffSplice0.720.310.95
AS-Quant0.780.311.00
RISUPPA20.630.091.00
rMATS0.580.300.50
diffSplice0.530.010.98
AS-Quant0.980.910.82
MXESUPPA20.660.371.00
rMATS0.760.690.50
diffSplice0.460.031.00
AS-Quant0.990.781.00
A3SSSUPPA20.800.560.99
rMATS0.490.580.50
diffSplice0.620.030.51
AS-Quant0.710.500.97
A5SSSUPPA20.830.660.99
rMATS0.460.570.50
diffSplice0.580.030.51
Table 3. Number of alternative splicing events identified by AS-Quant and three baseline methods between T s c 1 / MEFs with control and siU2af1. diffSplice cannot separate A3SS and A5SS.
Table 3. Number of alternative splicing events identified by AS-Quant and three baseline methods between T s c 1 / MEFs with control and siU2af1. diffSplice cannot separate A3SS and A5SS.
SERIMXEA3SSA5SS
AS-Quant25754310130
SUPPA21724612121117
rMATS1128151295116
diffSplice16956001125
Publisher’s Note: MDPI stays neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Share and Cite

MDPI and ACS Style

Fahmi, N.A.; Nassereddeen, H.; Chang, J.; Park, M.; Yeh, H.; Sun, J.; Fan, D.; Yong, J.; Zhang, W. AS-Quant: Detection and Visualization of Alternative Splicing Events with RNA-seq Data. Int. J. Mol. Sci. 2021, 22, 4468. https://0-doi-org.brum.beds.ac.uk/10.3390/ijms22094468

AMA Style

Fahmi NA, Nassereddeen H, Chang J, Park M, Yeh H, Sun J, Fan D, Yong J, Zhang W. AS-Quant: Detection and Visualization of Alternative Splicing Events with RNA-seq Data. International Journal of Molecular Sciences. 2021; 22(9):4468. https://0-doi-org.brum.beds.ac.uk/10.3390/ijms22094468

Chicago/Turabian Style

Fahmi, Naima Ahmed, Heba Nassereddeen, Jaewoong Chang, Meeyeon Park, Hsinsung Yeh, Jiao Sun, Deliang Fan, Jeongsik Yong, and Wei Zhang. 2021. "AS-Quant: Detection and Visualization of Alternative Splicing Events with RNA-seq Data" International Journal of Molecular Sciences 22, no. 9: 4468. https://0-doi-org.brum.beds.ac.uk/10.3390/ijms22094468

Note that from the first issue of 2016, this journal uses article numbers instead of page numbers. See further details here.

Article Metrics

Back to TopTop