Skip to main content

RCARE: RNA Sequence Comparison and Annotation for RNA Editing

Abstract

The post-transcriptional sequence modification of transcripts through RNA editing is an important mechanism for regulating protein function and is associated with human disease phenotypes. The identification of RNA editing or RNA-DNA difference (RDD) sites is a fundamental step in the study of RNA editing. However, a substantial number of false-positive RDD sites have been identified recently. A major challenge in identifying RDD sites is to distinguish between the true RNA editing sites and the false positives. Furthermore, determining the location of condition-specific RDD sites and elucidating their functional roles will help toward understanding various biological phenomena that are mediated by RNA editing. The present study developed RNA-sequence comparison and annotation for RNA editing (RCARE) for searching, annotating, and visualizing RDD sites using thousands of previously known editing sites, which can be used for comparative analyses between multiple samples. RCARE also provides evidence for improving the reliability of identified RDD sites. RCARE is a web-based comparison, annotation, and visualization tool, which provides rich biological annotations and useful summary plots. The developers of previous tools that identify or annotate RNA-editing sites seldom mention the reliability of their respective tools. In order to address the issue, RCARE utilizes a number of scientific publications and databases to find specific documentations respective to a particular RNA-editing site, which generates evidence levels to convey the reliability of RCARE. Sequence-based alignment files can be converted into VCF files using a Python script and uploaded to the RCARE server for further analysis. RCARE is available for free at http://www.snubi.org/software/rcare/.

Introduction

RNA editing is the post-transcriptional alteration of a single nucleotidesequence in primary messenger RNA (mRNA) or non-coding RNA (ncRNA) including micro-RNA (miRNA) transcripts [1]. The most widespread type of RNA editing in mammals is A-to-I editing, which is mediated by the adenosine deaminases acting on RNA (ADAR) enzyme [2–4]. Recent developments in DNA and RNA sequencing (RNA-Seq) technologies have led to the rapid identification of several forms of RNA editing in human cell lines, including G-to-A, C-to-U, T-to-C, C-to-A, G-to-C, T-to-A, and A-to-T [5, 6]. Most of the RNA editing or RNA-DNA difference (RDD) sites are located within intron, 5' untranslated region (UTR), 3'UTR [7], and Alu sequences. However, when RNA editing events occur in the coding region, they can cause nonsynonymous protein coding substitutions, alternative splicing, and changes in gene expression [7–9]. In addition, RNA editing can affect the activity of ncRNAs such as miRNA, siRNA (short interfering RNA), and piRNA (piwi-interacting RNA) [10]. Many RNA editing events are associated with a variety of human diseases such as epilepsy, brain ischemia, depression, and brain tumors [1].

In the last few years, huge amounts of DNA and RNA-Seq data have been generated and stored in public repositories such as GEO (http://www.ncbi.nlm.nih.gov/geo/) and ENCODE (http://genome.ucsc.edu/ENCODE/). In response, many tools have been developed for detecting or annotating RNA editing and RDD sites. Prediction tools for novel RNA editing sitessuch as rddChecker (http://genomics.jhu.edu/software/rddChecker/) perform RNA-DNA sequence comparisons with RNA-Seq and genomic DNA sequence data. The rddChecker searches for RDDs, filters known single-nucleotide polymorphisms, and determines novel RNA editing sites by comparison with known RNA editing sites. However, the rddChecker is known to suffer from false-positive results. And many of the RNA editing sites reported by Li et al. [11] were subsequently demonstrated to be false positives [12, 13]. From this point of view, a major challenge in identifying RNA editing or RDD sites is distinguishing between the true RNA editing sites and the false positives.

Several RNA editing-site databases have been developed that include information gathered from the literature or from manually accrued datasets such as DARNED (a database of RNA editing in humans)[14] and RADAR (a rigorously annotated database of A-to-I RNA editing)[15]. DARNED is a famous database that provides about 42,000 human RNA editing sites, while RADAR provides 1,343,464 human, 7,272 mouse, and 3,155 fly-tissue-specific RNA editing sites. Web-based RNA editing site annotation tools have been developed to take advantage of these databases. For example, ExpEdit[16] is an annotation tool that use the DARNED system for RNA editing sites. ExpEdit increases reliability by using more reliable data compared toother prediction tools, but is not able to identify novel RNA editing sites. It provides a user-friendly web interface for uploading raw RNA-Seq data such as FASTQ, SAM (sequence alignment map), and BAM (binary alignment map) files, and for exploring RNA editing. However, uploading raw RNA-Seq data cannot be completed within a practical time frame with this tool (i.e., it takes approximately 28 h to upload 700-MB BAM files). The Python package REDItools, which were developed to overcome the long uploading problem[17], perform novel RNA editing site detection and known RNA editing site annotation using DNA sequence and RNA-Seq data together from the same sample/individual or RNA-Seq data alone. VIRGO[18] is a web-based tool for identifying putative A-to-I editing sites in DNA sequences. However, Expedit and REDItools do not provide validity or reliability levelsfor each RNA editing site in the results data, and VIRGO provides only an A-to-I RNA editing form.

This study presented a new tool for RNA-Seq comparison and annotation for RNA editing (RCARE), which determines condition-dependent RNA editing sites, provides rich systematic annotations and the evidence levelof each RNA editing site. It identifies novel RNA editing sites in the same/individual DNA sequence and RNA-Seq variant call format (VCF) data, and delivers 'executive summary' plots for the annotation and comparison of multiple samples with RNA-Seq data through a user-friendly web interface. It also provides a Python script that users can implement to preprocess raw RNA-Seq data and convert FASTQ and BAM files into RNA VCF files within a practical time frame on a desktop computer. RCARE is freely available at http://www.snubi.org/software/rcare/.

Method

Data collection

RCARE integrates 314,880, 6,830, and 13,018 human mRNA editing sites downloaded from DARNED (NCBI37/hg19) [14] and human ENCODE RNA-Seq data [1], and Bahn et al, respectively. [5]. The reference-based evidence level of each RNA editing site was generated by downloading 1,379,404 and 10,115 human RNA editing sites (hg19) from RADAR [15] and Li et al. [11]. We also downloaded Homo_sapiens.GR-Ch37.69.gtf and RepeatMasker database information from Ensembl (http://ensembl.org) and UCSC (http://genome.ucsc.edu/buildGRCCh37/hg19) to annotate the RDD site into one of the following categories: ncRNA, Ensembl Gene (ENSG) ID, Transcript (ENST) ID, Exon ID (ENSE), and repetitive element (Alu,nonrepetitive). ANNOVAR (http://www.openbioinformatics.org/annovar/) [19] was also used to annotate the following genomic features: intron, intergenic, splicing region, downstream, upstream, 3'UTR, 5'UTR, and synonymous/nonsynonymous information (Table 1).

Table 1 Database resources for RNA editing, listing the sources of data currently included in RCARE, specific entries in the database, and the total unique RNA editing site covered by each data type.

RNA-Seq data preprocessing

RCARE provides a Python script for the automated conversion of a FASTQ or BAM file obtained from an RNA-Seq experiment into a VCF file with the hg19 reference genome (Figure 1A). TopHat [20], SAMtools [21], VCFtools [22], Tabix [23], and Bowtie2 [24] are run by the downloaded script on the client side to avoid the time-consuming uploading of huge RNA-Seq data. The parameters for TopHat and SAMtools are easily modifiable. Conversion utility consists of 2 types. The full version Conversion utility contains indispensable tools such as tophat, python script for BAM to VCF conversion, python script for DNA/RNA sequence variant comparison for finding novel RDD or RNA editing candidate sites and sample files for testing analysis. However, if a user already installed tools such as tophat, samtools and tabix, the user could download the light version Conversion utility. The light version excludes the aforementioned tools for faster downloads. Details of the data-processing pipeline are shown in Figure 1. If the user wants to use other tools for read mapping and variant calling, he could use other tools such as STAR and GATK, respectively, to create a VCF file as input for Annotation or Known-RNA-editing-site-compare functions. When both the DNA sequencing and RNA-Seq data are available, the RCARE RDD-compare function can be used to compare the paired VCF files created from those data. It is based on a python script and performs a comparison between RNA and DNA sequence variants according to chromosome, position, and reference/alternative sequences. This compare function can detect novel RDD or RNA editing candidate sites from DNA and RNA-VCF files. More precise detection of RNA editing sites requires both DNA and RNA VCF files obtained from the same/individual sample.

Figure 1
figure 1

RCARE RNA-Seq data processing steps and annotation result visualization. A) Conversion utility RNA-Seq data processing pipeline. B) Web interface for annotation and comparison analyses. C) Summary plots of annotation results

Comparison RNA editing sites

In RCARE, Known-RNA-editing-site-compare functions are functions which identifies RNA sites that are differentially edited between samples according to chromosome, position, and reference/alternative sequence. It also identifies RNA editing sites intersecting between input RNA-Seq samples. A detailed method for compare functions was described in Fig S3.

Construction of the web interface

RCARE is a web-based application that was created using HTML5 (Hypertext Markup Language 5), CSS3 (Cascading Style Sheets 3), jQuery, and Highcharts API (http://www.highcharts.com/). It also provides four functionalities: RNA-Seq data preprocessing, comparison, annotation, and visualization.

Result

We collected 321,008 RNA editing sites from DARNED (NCBI37/hg19) [14] and human ENCODE RNA-Seq data [1], and Bahn et al. [5]. The data sets comprised 154 samples in 30 sample types, 23 papers, and 11,299 genes with 12 different types of RNA editing sites (Figure 2). RCARE annotates each RNA editing site with nine annotation categories. The RCARE annotation function checks whether an editing site: (1) creates synonymous vs. nonsynonymous changes, (2) is located at a splicing junction, (3) has certain genomic features, (4) is Alu-associated, and (5) is located in a ncRNA; it also annotates (6) gene information (i.e., gene symbol, various IDs; see additional files), (7) sample origin, (8) reference articles, and (9) the reference-based evidence level. In addition, it provides the unique RNA editing sites of each sample and the intersection/difference between all pairwise sample comparisons with 17 useful biological annotations (Table 2).

Figure 2
figure 2

Data compositions. A) Venn diagram representing the number of RNA editing sites shared between DARNED, ENCODE, and Bahn et al. [5]. B) Number of RNA editing sites for each sample type. C) Bar plot representing the number of RNA editing sites for each editing type. D) Bar plot representing the number of RNA editing sites for each chromosome. E) Number of RNA editing sites for each genomic feature.

Table 2 Format of RCARE annotation Results.

Although the detection of RNA editing sites is important, the reliability of the RNA editing site is even more so. To enhance the reliability of the detected RNA editing sites, we generated Evidence levels according to the number of resources reporting corresponding RNA editing. First, we collected five RNA editing site-related resources (DARNED, RADAR, Bahn et al. [5], Li et al. [11], Park et al. [12]) and Alu sequence information (RepeatMasker, http://www.repeatmasker.org/). Second, we integrated aforementioned resources according to chromosome, position, and reference/alternative sequences and generated evidence levels according to the number of resources, which addressed corresponding RNA editing sites. Evidence levels consist of five levels (A-E), where A is the highest level (Table 3, Additional file 1). For example, if one RNA editing site is assigned level A, it appears in all five of the databases/papers searched. Whereas, the lowest class (E) represents the lowest level of evidence for RNA editing sites, whereby they appear in only one of the reference resources; 85% of RNA editing sites in integrated data belong to class D, appearing in two of the resources. This allows the user to decide whether a detected site is a false positive or a true positive, according to the graded scale of the evidence level.

Table 3 Evidence level classification scheme for RNA editing.

The web interface consists of three sections: user manual, download, and analysis. The user manual section provides instructions regarding the conversion utilities, annotation, comparison, and results description (Figure 1B). All manual files can be downloaded as PDF files. The download section provides conversion utilities that can be downloaded. We provide two versions of the conversion utilities: full and light. The full version includes all RNA-Seq processing tools such as TopHat, while the light version does not. The analysis section provides annotation and omparison analysis. The annotation part provides 16 useful biological annotations and the evidence level of each RNA editing site from the VCF format of the RNA-Seq data. The compare part provides the RNA editing sites of each sample and the intersection/difference between all pairwise samples with 16 useful biological annotations and evidence levels. The results page provides summary plots based on annotation categories including the distributions of genomic features, genes, ncRNAs, synonymous vs. nonsynonymous changes, types of RNA editing, and the distributions of detected RNA editing sites in each chromosome or sample (Figure 1C). All image files for plots and annotation files can be downloaded. The test results with three RNA-Seq data sets for MCF-7 (a breast cancer cell line), HUVEC (a human umbilical vein endothelial cell line) and HeLa-S3 (a cervical carcinoma cell line) downloaded from ENCODE (http://genome.ucsc.edu/ENCODE/) yielded 2437, 646 and 1190 RNA editing sites, respectively; we obtained 205, 605 and 334 RNA editing sites that had evidence levels of A-C from HUVEC, MCF-7 and HeLa-S3; however, these represent only 31.7%, 24.8% and 28.07% of the total RNA editing sites. This finding shows that a good evidence level is essential for RNA editing detection and annotation analysis. We also accomplish the Known-RNA-editing-site-compare functions between MCF-7 and HUVEC. As a result, we identified 2,080 breast-cancer-specific RNA editing site were detected from MCF-7. These results demonstrate the importance of detecting condition-specific RNA editing sites.

We measured execution times of Expedit and RCARE using a 37.3 Mb sample bam file. Conversion processing of RCARE was performed in 192 seconds on a 3.0 GHz CPU, 2048 MB RAM desktop environment for converting BAM to VCF. RCARE RNA editing site annotations took 7 seconds under 14.19 MBps network environments.

Discussion

Efficient and user-friendly web-based system for trustworthy RNA-editing-site annotation, comparison and graph visualization. RCARE contains 321,008 human RNA editing sites with rich biological annotations and useful summary plots, as well as evidence levels to indicate the reliability of each RNA editing site. Furthermore, it provides a tool for converting sequence-based alignment files into VCF files using a Python script; converted VCF files can be uploaded to the RCARE server for further analysis. The RCARE web interface can be used to easily annotate and visualize VCF-formatted RNA-Seq data, and to download results into CSV and JPG files.

Identification of novel RNA-editing sites became the focus of RNA-editing research about 2~3 years ago [1, 5, 11]. In recent years, however, the spotlight has shifted to analyzing reliability of identified RNA-editing sites because research revealed that numerous RNA-editing sites were, in fact, false positives. We anticipate that RCARE's evidence level will greatly augment the field of RNA-editing site research. RCARE will help toward the identification of trustworthy RNA editing sites.

References

  1. Park E, et al: RNA editing in the human ENCODE RNA-seq data. Genome Res. 2012, 22: 1626-33. 10.1101/gr.134957.111. Sep

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  2. Kim U, et al: Molecular cloning of cDNA for double-stranded RNA adenosine deaminase, a candidate enzyme for nuclear RNA editing. Proc Natl Acad Sci USA. 1994, 91: 11457-61. 10.1073/pnas.91.24.11457. Nov 22

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  3. Kumar M, Carmichael GG: Nuclear antisense RNA induces extensive adenosine modifications and nuclear retention of target transcripts. Proc Natl Acad Sci USA. 1997, 94: 3542-7. 10.1073/pnas.94.8.3542. Apr 15

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  4. Wagner RW, et al: A double-stranded RNA unwinding activity introduces structural alterations by means of adenosine to inosine conversions in mammalian cells and Xenopus eggs. Proc Natl Acad Sci USA. 1989, 86: 2647-51. 10.1073/pnas.86.8.2647. Apr

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  5. Bahn JH, et al: Accurate identification of A-to-I RNA editing in human by transcriptome sequencing. Genome Res. 2012, 22: 142-50. 10.1101/gr.124107.111. Jan

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  6. Abecasis GR, et al: A map of human genome variation from population-scale sequencing. Nature. 2010, 467: 1061-73. 10.1038/nature09534. Oct 28

    Article  PubMed  Google Scholar 

  7. Nishikura K: Functions and regulation of RNA editing by ADAR deaminases. Annu Rev Biochem. 2010, 79: 321-49. 10.1146/annurev-biochem-060208-105251.

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  8. Maas S, et al: A-to-I RNA editing and human disease. RNA Biol. 2006, 3: 1-9. 10.4161/rna.3.1.2495. Jan-Mar

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  9. Nishikura K: Editor meets silencer: crosstalk between RNA editing and RNA interference. Nat Rev Mol Cell Biol. 2006, 7: 919-31. 10.1038/nrm2061. Dec

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  10. Wulff BE, Nishikura K: Modulation of microRNA expression and function by ADARs. Curr Top Microbiol Immunol. 2012, 353: 91-109.

    CAS  PubMed  Google Scholar 

  11. Li M, et al: Widespread RNA and DNA sequence differences in the human transcriptome. Science. 2011, 333: 53-8. 10.1126/science.1207018. Jul 1

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  12. Pickrell JK, et al: Comment on "Widespread RNA and DNA sequence differences in the human transcriptome. Science. 2012, 335: 1302-author reply 1302, Mar 16

    Article  CAS  PubMed  Google Scholar 

  13. Lin W, et al: Comment on "Widespread RNA and DNA sequence differences in the human transcriptome". Science. 2012, 335: 1302-author reply 1302, Mar 16

    Article  CAS  PubMed  Google Scholar 

  14. Kiran A, Baranov PV: DARNED: a DAtabase of RNa EDiting in humans. Bioinformatics. 2010, 26: 1772-6. 10.1093/bioinformatics/btq285. Jul 15

    Article  CAS  PubMed  Google Scholar 

  15. Ramaswami G, Li JB: RADAR: a rigorously annotated database of A-to-I RNA editing. Nucleic Acids Res. 2014, 42: D109-13. 10.1093/nar/gkt996. Jan

    Article  CAS  PubMed  Google Scholar 

  16. Picardi E, et al: ExpEdit: a webserver to explore human RNA editing in RNA-Seq experiments. Bioinformatics. 2011, 27: 1311-2. 10.1093/bioinformatics/btr117. May 1

    Article  CAS  PubMed  Google Scholar 

  17. Picardi E, Pesole G: REDItools: high-throughput RNA editing detection made easy. Bioinformatics. 2013, 29: 1813-4. 10.1093/bioinformatics/btt287. Jul 15

    Article  CAS  PubMed  Google Scholar 

  18. Distefano R, et al: VIRGO: visualization of A-to-I RNA editing sites in genomic sequences. BMC Bioinformatics. 2013, 14 (Suppl 7): S5-10.1186/1471-2105-14-S7-S5.

    Article  PubMed  PubMed Central  Google Scholar 

  19. Wang K, et al: ANNOVAR: functional annotation of genetic variants from high-throughput sequencing data. Nucleic Acids Res. 2010, 38: e164-10.1093/nar/gkq603. Sep

    Article  PubMed  PubMed Central  Google Scholar 

  20. Trapnell C, et al: TopHat: discovering splice junctions with RNA-Seq. Bioinformatics. 2009, 25: 1105-11. 10.1093/bioinformatics/btp120. May 1

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  21. Li H, et al: The Sequence Alignment/Map format and SAMtools. Bioinformatics. 2009, 25: 2078-9. 10.1093/bioinformatics/btp352. Aug 15

    Article  PubMed  PubMed Central  Google Scholar 

  22. Danecek P, et al: The variant call format and VCFtools. Bioinformatics. 2011, 27: 2156-8. 10.1093/bioinformatics/btr330. Aug 1

    Article  CAS  PubMed  PubMed Central  Google Scholar 

  23. Li H: Tabix: fast retrieval of sequence features from generic TAB-delimited files. Bioinformatics. 2011, 27: 718-9. 10.1093/bioinformatics/btq671. Mar 1

    Article  PubMed  PubMed Central  Google Scholar 

  24. Langmead B, Salzberg SL: Fast gapped-read alignment with Bowtie 2. Nat Methods. 2012, 9: 357-9. 10.1038/nmeth.1923. Apr

    Article  CAS  PubMed  PubMed Central  Google Scholar 

Download references

Declaration

Publication of this article has been funded by the ICT R&D program of MSIP/IITP [B0101-15-247, Development of open ICT healing platform using personal health data].

This research was supported by the ICT R&D program of MSIP/IITP [B0101-15-247, Development of open ICT healing platform using personal health data] and by a grant of the Korean Health Technology R&D Project, Ministry of Health and Welfare (HI13C2164).

This article has been published as part of BMC Medical Genomics Volume 8 Supplement 2, 2015: Selected articles from the 4th Translational Bioinformatics Conference and the 8th International Conference on Systems Biology (TBC/ISB 2014). The full contents of the supplement are available online at http://www.biomedcentral.com/bmcmedgenomics/supplements/8/S2.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Ju Han Kim.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors' contributions

S. Lee conceived and designed the system, and also implemented the database and web interface (C. Park assisted the implementation of the database). J. Joung supported the project by providing biological information on RNA editing. S. Lee wrote the paper, with J. Park facilitating the process. J. Kim supervised the project. All authors read and approved the final manuscript

Electronic supplementary material

12920_2015_558_MOESM1_ESM.png

Additional file 1: Number of RNA editing sites for each genomic feature within each evidence level. A) Number of RNA editing sites at each evidence level. B) Evidence level annotations in relation to genomic features. The enrichments for genic features at each evidence level from RCARE are also shown. (PNG 495 KB)

12920_2015_558_MOESM2_ESM.png

Additional file 2: The ratio of each evidence level within three cell line RNA-seq data. A) The ratio of evidence levels A-C versus D-E in detected RNA-editing sites within three cell lines including MCF-7 (a breast cancer cell line), HUVEC (a human umbilical vein endothelial cell line) and HeLa-S3 (a cervical carcinoma cell line). B) Number of RNA editing sites at each evidence level within three cell llines. (PNG 395 KB)

Additional file 3: RCARE webpage user manuals. (DOCX 2 MB)

Additional file 4: RCARE convert utilities manuals. (DOCX 21 KB)

Rights and permissions

Open Access  This article is licensed under a Creative Commons Attribution 4.0 International License, which permits use, sharing, adaptation, distribution and reproduction in any medium or format, as long as you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons licence, and indicate if changes were made.

The images or other third party material in this article are included in the article’s Creative Commons licence, unless indicated otherwise in a credit line to the material. If material is not included in the article’s Creative Commons licence and your intended use is not permitted by statutory regulation or exceeds the permitted use, you will need to obtain permission directly from the copyright holder.

To view a copy of this licence, visit https://creativecommons.org/licenses/by/4.0/.

The Creative Commons Public Domain Dedication waiver (https://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated in a credit line to the data.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Lee, S.Y., Joung, JG., Park, C.H. et al. RCARE: RNA Sequence Comparison and Annotation for RNA Editing. BMC Med Genomics 8 (Suppl 2), S8 (2015). https://doi.org/10.1186/1755-8794-8-S2-S8

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/1755-8794-8-S2-S8

Keywords