Skip to main content

ISVASE: identification of sequence variant associated with splicing event using RNA-seq data

Abstract

Background

Exon recognition and splicing precisely and efficiently by spliceosome is the key to generate mature mRNAs. About one third or a half of disease-related mutations affect RNA splicing. Software PVAAS has been developed to identify variants associated with aberrant splicing by directly using RNA-seq data. However, it bases on the assumption that annotated splicing site is normal splicing, which is not true in fact.

Results

We develop the ISVASE, a tool for specifically identifying sequence variants associated with splicing events (SVASE) by using RNA-seq data. Comparing with PVAAS, our tool has several advantages, such as multi-pass stringent rule-dependent filters and statistical filters, only using split-reads, independent sequence variant identification in each part of splicing (junction), sequence variant detection for both of known and novel splicing event, additional exon-exon junction shift event detection if known splicing events provided, splicing signal evaluation, known DNA mutation and/or RNA editing data supported, higher precision and consistency, and short running time. Using a realistic RNA-seq dataset, we performed a case study to illustrate the functionality and effectiveness of our method. Moreover, the output of SVASEs can be used for downstream analysis such as splicing regulatory element study and sequence variant functional analysis.

Conclusions

ISVASE is useful for researchers interested in sequence variants (DNA mutation and/or RNA editing) associated with splicing events. The package is freely available at https://sourceforge.net/projects/isvase/.

Background

Alternative splicing is a normal phenomenon in eukaryotes and greatly increase the biodiversity of proteins. About 95% of multi-exonic genes are alternatively spliced in human [1]. The extreme example is the Drosophila Dscam gene, which produces thousands of protein isoforms by alternative splicing [2]. Classic pre-mRNA splicing is recognized and regulated by core splicing signals (5′ splice site (5′ ss), 3′ splice site (3′ ss), branch point sequence) and auxiliary sequences (splicing regulatory elements). Aberrant RNA splicing has become a common disease-causing mechanism, which can lead to hereditary disorders and cancers. Recent studies indicate that one third or a half of disease-causing mutations can affect RNA splicing [3, 4]. Therefore, identification of sequence variant associated with splicing event (SVASE) becomes a meaningful procedure to illustrate the pathogenesis of diseases. Usually, sequence variant can result in aberrant splicing by disturbing regulatory element sequence or changing splice site [5]. For example, two sequence variants in splicing regulatory elements induce the aberrant splicing of BRCA2 exon 7 [6]. Moreover, RNA editing also can effect RNA splicing in transcriptome level [7].

Nowadays, RNA-seq has become a routine method for gene expression calling in multiple studies and can be also used to identify sequence variant and splicing event simultaneously [8, 9]. However, there is only one bioinformatic tool (PVAAS) available for directly identifying genome-wide SVASE [10], which has some shortages, such as dependency on known splicing sites, only for novel splicing events, high false positive and long running time. Herein, we develop ISVASE, a suite of Perl scripts, to address the shortcomings of PVAAS and provide new functions for downstream analysis. The only necessary input files are genome sequence (FASTA format) and sequence alignment (BAM or SAM format) [11] files. The sequence alignment file must contain split-reads mapping result produced by software like GSNAP [12] and TopHat [13]. We also recommend users to provide known splicing events in GTF, GFF or BED format for junction shift event identification if concerned.

Implementation

The basic working principle of SVASE identification includes three main steps: (1) identify alternative splicing events; (2) identify sequence variants in specific splicing event using split-reads; and (3) evaluate the association between sequence variants and splicing events (see Fig. 1).

Fig. 1
figure 1

Schematic diagram of the ISVASE software. a Identify splicing variants in RNA-seq data. All splicing variants can be divided into four types according to relationship between target splicing variant (red colour) and other splicing variants (from left to right): (i) unique splicing variant; (ii) splicing variants with same junction start; (iii) splicing variants with same junction end; and (iv) splicing variants with same junction start or end. b Identify sequence variants for each splicing variant and all related splicing variants. To handle all splicing variant types, we identify sequence variants for two parts of splicing separately. In the left part, for junctions with orange, yellow and red colour, the all related splicing variants should be three (all these junctions); however, for junctions with green and blue colour, the total junction is one (itself). Similarly, in the right part, junctions with red, green and blue colour have three all related splicing variants while junctions with orange and yellow colour only has one related junction (itself). c Identify associations. This step includes three significant judgements for sequence variants, junction existence and association between sequence variants and junctions, respectively. The example shown two junctions with same junction end. For junction one (top), two sequence variants are identified (left G(ref)- > C(alt) and right G(ref)- > A(alt)). In sequence variant significant judgement, left is filtered (p value = 1) while right passes the test (p value = 0.0476). In junction significant judgement and association judgement, p value of top junction is 0.0128 (significant) and 0.0070 (significant) respectively. Dashed lines represent gaps in the alignment

Based on sequence alignment result, ISVASE first filters mapped reads using stringent rule-dependent filters, such as low base quality (<Q30), low mapping quality (unpaired reads for paired-end data, PCR duplication, quality control, multiple mapping, mismatch, insertion and deletion) and short read length (<30 bp). Only split-reads with at least 8 bp anchor size in both parts of splicing event (junction) can be used to identify putative splicing event. Initially, splicing events with low read depth (<3) are discarded. Low abundant splicing events are also filtered out as background expression by applying Fisher’s exact test to the putative splicing event and its related splicing events (sharing 5’ss or 3’ss). Here, ISVASE divides each splicing event into two independent parts based on 5’ss and 3’ss. ISVASE can remove known splicing events using annotation file in GTF, GFF or BED format by option “-k no”. Although excellent software for sequence variant calling has existed such as GATK [14] and samtools [15], their results are hard to be used for SVASE calling, which needs to clarify specific sequence variants for unique splicing event. Thus, ISVASE adopts de novo sequence variant identification by only using junction-supporting split-reads. The observed sequence variant candidates are filtered by following criteria: reads depth (<3), alternative allele (ALT) supporting reads number (<3), ALT proportion (<0.1) and the significance of variant (p > 0.05, Fisher’s exact test).

The practice of SVASE identification has a bit difference depending on whether the ALT frequencies are consistent between target splicing event and all related splicing events. We calculated the ALT frequencies for each sequence variants using reads of all splicing events and the target splicing event, respectively. If consistence, the association is assessed only using reads from target splicing event. Otherwise, total related reads are used. ISVASE applies same method as PVAAS to evaluate the significance of association. Besides, ISVASE assesses splicing signal by MaxEntScan [16] and identifies junction shift events to reduce the false positive of splicing event calling. Furthermore, DNA mutation and/or RNA editing profiles (like dbSNP [17], DARNED [18], RADAR [19] or user provided DNA mutation or RNA editing sites) can be used to assign the source type of sequence variants. ISVASE outputs the detailed statistical results with figures and tables. ISVASE also extracts the flanking sequence for sequence variants, which can be used to predict exonic splicing enhancer (ESE) motifs using tools like ESEfinder [20] and Human Splicing Finder [21]. The output of identified SVASEs can be accepted by ANNOVAR [22] and SnpEff [23] for further functional analysis like KEGG pathway and Gene Ontology. The code of ISVASE was written using Perl (v5.18.4), the figures were created by R (v3.1.2) while the sequence alignment file was operated by samtools (v1.2).

Results and Discussion

To demonstrate the functionality of ISVASE and compare with PVAAS, PVAAS testing data (downloaded from website http://pvaas.sourceforge.net/) was used. PVAAS (v0.1.5) identified 8 SVASEs (belonging to new splicing events), while ISVASE obtained 172 SVASEs and 14 of them were new splicing events (Table 1, Additional files 1 and 2). Two software only share one SVASE, which probably is genuine according to dbscSNV [24]. Among other 7 PVAAS unique SVASEs, 1 SVASE has a low ALT ratio (<=0.01), 1 SVASE is supported by un-split reads and remaining 5 SVASEs are identified only by a small part of target junction supporting reads (0.8% ~8%). All of these error-prone SVASEs have been filtered in our tool. All 14 SVASEs belonging to new splicing events in our result have high confident evidences such as mapping quality, ALT reads and other filter criteria mentioned above. Among 158 SVASEs in known splicing events, 55 SVASEs are non-reference homozygous, 66 SVASEs have more than 80% ALT reads, and 110 SVASEs have more than 50% ALT reads. Comparing SVASEs with dbSNP and RADAR database, we found that ISVASE has better performance than PVAAS both for novel and all SVASEs (Table 2). Moreover, ISVASE run faster than PVAAS. For test data (7.26 million reads), PVAAS takes 1.63 h, while ISVASE only needs 11 min for novel splicing events or 13 min for all splicing events (Table 3).

Table 1 The statistics of SVASE identification using PVAAS and ISVASE
Table 2 The performance comparison between PVAAS and ISVASE
Table 3 The running time comparison between PVAAS and ISVASE

To further reveal the advantage of ISVASE, we also test another real data set with 4 RNA-seq samples for human glioblastoma cell line U87MG (SRR388226 and SRR388227 are control samples and SRR388228 and SRR388229 are ADAR knockdown samples) [25]. The raw data was trimmed by Trimmomatic [26] and aligned by GSNAP (only concordant mapping results were used for downstream analysis) [12]. Using ISVASE, 134 and 120 SVASEs (87 common) were obtained for control data, while 187 and 168 SVASEs (119 common) for knockdown data in new splicing events. If considering all splicing events, 2105 and 2298 common SVASEs were identified in control and knockdown data (Table 1, Additional files 3, 4, 5, and 6). In each sample, at most three SVASEs belonging to RNA editing sites in RADAR database were detected (totally four SVASEs belonging to RADAR database), and more than 82% SVASEs existed in dbSNP. In comparison, PVAAS got 61 and 63 SVASEs (28 common) for control data, while 93 and 89 SVASEs (31 common) for knockdown data (Table 1, Additional files 7, 8, 9, and 10). In PVAAS result, there wasn’t any SVASE belonging to RNA editing sites in RADAR database and at most 27% SVASEs existed in dbSNP. These results indicated that PVAAS has higher false positive rate comparing with ISVASE (Table 2). Using repeat samples, we also found that PVAAS has lower consistency rate comparing with ISVASE (about 47% vs. about 83%) (Table 2). Moreover, for each sample, ISVASE showed an advantage of running time to PVAAS (about 3 h vs. 14.34 h) (Table 3).

The SVASEs identified by ISVASE can be used for downstream analysis easily. For example, we used 65 common SVASEs in new splicing events from the above four samples to do further analysis. We annotated these SVASEs by ANNOVAR and found 28 related genes (Additional file 11). Among them, 20, 9 and 8 SVASEs located in HLA, HCG4B and AHNAK2 genes. HLA genes play important roles in tumor immune surveillance and escape, and HCG4B gene is a pseudogene of HLA complex group. AHNAK2 gene is associated with calcium channel proteins and its exon 7 size is almost 18 kb. We found 8 SVASEs associated with 5 new splicing events inside the exon 7. Gene Ontology enrichment analysis found these 28 genes are significantly enriched in cancer related functions, such as antigen processing and presentation, response to type I interferon and interferon-gamma (Table 4). We also used ESEfinder to detect ESE motifs and found 57 of 65 SVASEs located in predicted ESE motifs. This result indicates most of SVASEs perform their function possibly by influencing ESE motifs of splicing events. Moreover, SVASEs have some basic characteristics (using SRR388226 data as an example), such as high proportion of canonical splicing signal GT-AG (or reverse complement CT-AC), similar signal scores for splice sites with reference or alternative allele, tendency to junction breakpoints, and high frequency of A- > G/T- > C and G- > A/C- > T transitions (58.96% in new splicing events and 75.13% in all splicing events) (Fig. 2).

Table 4 Gene Ontology enrichment analysis for genes related with 65 common SVASEs using PANTHER (filtered redundant records)
Fig. 2
figure 2

The characteristics of SVASEs between novel and all SVASE sites in sample SRR388226. The density of junction reads number, the bar plot of junction number for different junction splicing signals, the boxplot of junction reads number distribution for different junction splicing signals, the density of splicing signal score for variant replaced sequence and reference sequence, the histogram plot of distances between sequence variant and exon 5′ side, the histogram plot of distances between sequence variant and exon 3′ side, the boxplot of distance distribution between sequence variant type and junction breakpoint, and the bar plot of sequence variant number for different sequence variant types are shown for SVASEs located in new splicing events (the upper half) and all splicing events (the lower half)

Conclusions

ISVASE provides users to identify SVASEs simply and fast using RNA-seq data. It identifies SVASEs for both parts of splicing event (or junction) separately. To reduce false positives due to sequencing errors, ISVASE applies several stringent rule-depended filters and statistical filters in different steps. ISVASE can evaluate junction shift events and junction signals (5′ ss and 3′ ss) to remove false positive splicing events. It also can use user provided DNA mutation and/or RNA editing data to designate types of sequence variants. To facilitate downstream analysis, ISVASE obtains flanking sequences and VCF output for other tools usage. ISVASE also provides 6 tables and 8 figures to describe the characteristics of SVASEs. In summary, our approach enabled de novo identification of SVASEs, which sets the stage for further mechanistic studies.

Abbreviations

3′ ss:

3′ splice site

5′ ss:

5′ splice site

ALT:

alternative allele

ESE:

exonic splicing enhancer

ISVASE:

Identification of sequence variant associated with splicing event

PVAAS:

Program to identify variants associated with aberrant splicing

SE:

splicing event

SV:

Sequence variant

SVASE:

Sequence variant associated with splicing event

References

  1. Pan Q, Shai O, Lee LJ, Frey BJ, Blencowe BJ. Deep surveying of alternative splicing complexity in the human transcriptome by high-throughput sequencing. Nat Genet. 2008;40(12):1413–5.

    Article  CAS  PubMed  Google Scholar 

  2. Sun W, You X, Gogol-Döring A, He H, Kise Y, Sohn M, et al. Ultra-deep profiling of alternatively spliced Drosophila Dscam isoforms by circularization-assisted multi-segment sequencing. EMBO J. 2013;32(14):2029–38.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  3. Lim KH, Ferraris L, Filloux ME, Raphael BJ, Fairbrother WG. Using positional distribution to identify splicing elements and predict pre-mRNA processing defects in human genes. Proc Natl Acad Sci. 2011;108(27):11093–8.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  4. Cartegni L, Chew SL, Krainer AR. Listening to silence and understanding nonsense: exonic mutations that affect splicing. Nat Rev Genet. 2002;3(4):285–98.

    Article  CAS  PubMed  Google Scholar 

  5. Ward AJ, Cooper TA. The pathobiology of splicing. J Pathol. 2010;220(2):152–63.

    CAS  PubMed  PubMed Central  Google Scholar 

  6. Gaildrat P, Krieger S, Di Giacomo D, Abdat J, Révillion F, Caputo S, et al. Multiple sequence variants of BRCA2 exon 7 alter splicing regulation. J Med Genet. 2012;49(10):609–17.

    Article  CAS  PubMed  Google Scholar 

  7. Schoft VK, Schopoff S, Jantsch MF. Regulation of glutamate receptor B pre-mRNA splicing by RNA editing. Nucleic Acids Res. 2007;35(11):3723–32.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  8. Adamopoulos PG, Kontos CK, Tsiakanikas P, Scorilas A. Identification of novel alternative splice variants of the BCL2L12 gene in human cancer cells, using next-generation sequencing methodology. Cancer Lett. 2016;

  9. Li YI, van de Geijn B, Raj A, Knowles DA, Petti AA, Golan D, et al. RNA splicing is a primary link between genetic variation and disease. Science. 2016;352(6285):600–4.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  10. Wang L, Nie JJ, Kocher J-PA. PVAAS: identify variants associated with aberrant splicing from RNA-seq. Bioinformatics. 2015;31(10):1668–70.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  11. Li H, Handsaker B, Wysoker A, Fennell T, Ruan J, Homer N, et al. The sequence alignment/map format and SAMtools. Bioinformatics. 2009;25(16):2078–9.

    Article  PubMed  PubMed Central  Google Scholar 

  12. Wu TD, Nacu S. Fast and SNP-tolerant detection of complex variants and splicing in short reads. Bioinformatics. 2010;26(7):873–81.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  13. Trapnell C, Pachter L, Salzberg SL. TopHat: discovering splice junctions with RNA-Seq. Bioinformatics. 2009;25(9):1105–11.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  14. McKenna A, Hanna M, Banks E, Sivachenko A, Cibulskis K, Kernytsky A, et al. The Genome Analysis Toolkit: a MapReduce framework for analyzing next-generation DNA sequencing data. Genome Res. 2010;20(9):1297–303.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  15. Li H. A statistical framework for SNP calling, mutation discovery, association mapping and population genetical parameter estimation from sequencing data. Bioinformatics. 2011;27(21):2987–93.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  16. Yeo G, Burge CB. Maximum entropy modeling of short sequence motifs with applications to RNA splicing signals. J Comput Biol. 2004;11(2–3):377–94.

    Article  CAS  PubMed  Google Scholar 

  17. Sherry ST, Ward M-H, Kholodov M, Baker J, Phan L, Smigielski EM, et al. dbSNP: the NCBI database of genetic variation. Nucleic Acids Res. 2001;29(1):308–11.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  18. Kiran A, Baranov PV. DARNED: a DAtabase of RNa EDiting in humans. Bioinformatics. 2010;26(14):1772–6.

    Article  CAS  PubMed  Google Scholar 

  19. Ramaswami G, Li JB: RADAR: a rigorously annotated database of A-to-I RNA editing. Nucleic Acids Res. 2013. doi:10.1093/nar/gkt99.

  20. Cartegni L, Wang J, Zhu Z, Zhang MQ, Krainer AR. ESEfinder: a web resource to identify exonic splicing enhancers. Nucleic Acids Res. 2003;31(13):3568–71.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  21. Desmet F-O, Hamroun D, Lalande M, Collod-Béroud G, Claustres M, Béroud C. Human Splicing Finder: an online bioinformatics tool to predict splicing signals. Nucleic Acids Res. 2009;37(9):e67.

    Article  PubMed  PubMed Central  Google Scholar 

  22. Wang K, Li M, Hakonarson H. ANNOVAR: functional annotation of genetic variants from high-throughput sequencing data. Nucleic Acids Res. 2010;38(16):e164.

    Article  PubMed  PubMed Central  Google Scholar 

  23. Cingolani P, Platts A, Wang LL, Coon M, Nguyen T, Wang L, et al. A program for annotating and predicting the effects of single nucleotide polymorphisms, SnpEff: SNPs in the genome of Drosophila melanogaster strain w1118; iso-2; iso-3. Fly. 2012;6(2):80–92.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  24. Jian X, Boerwinkle E, Liu X. In silico prediction of splice-altering single nucleotide variants in the human genome. Nucleic Acids Res. 2014;42(22):13534–44.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  25. Bahn JH, Lee J-H, Li G, Greer C, Peng G, Xiao X. Accurate identification of A-to-I RNA editing in human by transcriptome sequencing. Genome Res. 2012;22(1):142–50.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  26. Bolger AM, Lohse M, Usadel B: Trimmomatic: a flexible trimmer for Illumina sequence data. Bioinformatics. 2014. doi:10.1093/bioinformatics/btu170.

Download references

Acknowledgements

Technical supports were provided by the CAS Key Laboratory of Genome Science and Information, Beijing Institute of Genomics, Chinese Academy of Sciences, the People’s Republic of China. The authors thank the anonymous reviewers for critical comments and helpful suggestions.

Funding

This study is supported by grants from National Natural Science Foundation of China (Grant No. 31501042, 31,271,385 and 31,200,957), the Strategic Priority Research Program of the Chinese Academy of Sciences (Grant No. XDA08020102), and KACST grant 1035–35 from King Abdulaziz City for Science and Technology (KACST), Kingdom of Saudi Arabia. None of the funding bodies have played any part in the design of the study, in the collection, analysis, and interpretation of the data, or in the writing of the manuscript.

Availability of data and materials

ISVASE package is freely available at https://sourceforge.net/projects/isvase/. All data generated or analyzed during this study are included in this article and its supplementary information files.

Project name: ISVASE

Operating system: Unix/Linux

Programming language: Perl

Other requirements: Perl Environment (perl v5.18.4 or later), Perl module Text::NSP and Statistics::Multtest, R Environment (R 3.1.2 or later), samtools (v1.2)

License: GNU General Public License version 3.0 (GPLv3)

Any restrictions to use by non-academics: None

Author’s contributions

HAA, WFL and QL contributed equally to this work. HAA, WFL and QL written the codes for tool. HAA, WFL, QL, SNH and JY led the research and wrote the manuscript. All authors read and approved the final manuscript.

Competing interests

The authors declare that they have no competing interests.

Consent for publication

Not applicable.

Ethics approval and consent to participate

Not applicable.

Publisher’s Note

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

Author information

Authors and Affiliations

Authors

Corresponding authors

Correspondence to Jun Yu or Songnian Hu.

Additional files

Additional file 1:

PVAAS result for its test data. (XLS 753 bytes)

Additional file 2:

ISVASE result for PVAAS test data. (XLS 17 kb)

Additional file 3:

ISVASE result for SRR388226. (XLS 365 kb)

Additional file 4:

ISVASE result for SRR388227. (XLS 362 kb)

Additional file 5:

ISVASE result for SRR388228. (XLS 384 kb)

Additional file 6:

ISVASE result for SRR388229. (XLS 391 kb)

Additional file 7:

PVAAS result for SRR388226. (XLS 4 kb)

Additional file 8:

PVAAS result for SRR388227. (XLS 4 kb)

Additional file 9:

PVAAS result for SRR388228. (XLS 6 kb)

Additional file 10:

PVAAS result for SRR388229. (XLS 6 kb)

Additional file 11:

Genes of 65 common SVASEs in new splicing events identified by ISVASE for four samples. (DOCX 12 kb)

Rights and permissions

Open Access This article is distributed under the terms of the Creative Commons Attribution 4.0 International License (http://creativecommons.org/licenses/by/4.0/), which permits unrestricted use, distribution, and reproduction in any medium, provided you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons license, and indicate if changes were made. The Creative Commons Public Domain Dedication waiver (http://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Aljohi, H.A., Liu, W., Lin, Q. et al. ISVASE: identification of sequence variant associated with splicing event using RNA-seq data. BMC Bioinformatics 18, 320 (2017). https://doi.org/10.1186/s12859-017-1732-7

Download citation

  • Received:

  • Accepted:

  • Published:

  • DOI: https://doi.org/10.1186/s12859-017-1732-7

Keywords