Contents

1 Installation

EventPointer can be installed from Bioconductor using the BiocManager package:

library(BiocManager)

if (!requireNamespace("BiocManager", quietly=TRUE))
    install.packages("BiocManager")

BiocManager::install("EventPointer")

2 Introduction

EventPointer R package provides users a simplified way to identify, classify and visualize alternative splicing events. The steps required by the algorithm are almost identical for both technologies. The algorithm only differs in its inital step.

Figure 1. Definition of alternative splicing events for EventPointer

Figure 1. Definition of alternative splicing events for EventPointer

Figure 2 shows each of the main steps in a graphical layout.

This vignette is divided in two sections. In the first one, the complete analysis for junction arrays is described and the second one describes the analysis for RNA-Seq data.

To cite EventPointer:

Figure 2. Overview of EventPointer

Figure 2. Overview of EventPointer

3 Analysis of junction arrays

3.1 Overview of junction arrays

EventPointer is prepared to work with different Affymetrix arrays, such as: HTA 2.0, Clariom-D, RTA and MTA.

To build the CDF file (to work under the aroma.affymetrix framework), EventPointer requires a GTF file with the reference transcriptome information. In case not provided, the algorithm automatically downloads the required information from different databases such as ENSEMBL or UCSC. As the probes for the HTA 2.0 array are mapped to the HG19 genome, the latests versions of the ensembl and ucsc genome, mapped to the hg19 version, will be downloaded. For the other arrays, the following genomes are used: ClariomD = GRCh38, MTA = mm10 and RTA = rn6.

The required files are:

  1. Exon probes genomic position (Tab separated .txt file)
  2. Junction probes genomic position (Tab separated .txt file)
  3. Reference transcriptome (GTF file)

Files 1 and 2 contain probe information for the array. These files and the corresponding CDF files can be downloaded from the following URL: EventPointer Dropbox

The format of these files is briefly explained in the following paragraphs:

For the Exon Probes, the file corresponds to a tab separated .txt file composed of 11 columns that include: Probe Id, X coordinate in the array, Y coordinate in the array, Transcript Cluster Id, Probeset Id, Probeset name, Probe sequence, chromosome, start, end and strand.

The Junction probes file is also a tab separated .txt composed of 10 columns: Probe Id, X coordinate in the array, Y coordinate in the array, Transcript Cluster Id, Probeset Id, Probeset name, Probe sequence, chromosome and probe alignments.

For the GTF the standard format is used. (For more information see GTF)

This vignette uses the probes and annotation file for the DONSON gene in order to run the examples in a short amount of time. To generate the corresponding CDF file for the whole genome, the files from the Dropbox link must be used.

Note: It is advisable to work with reference GTF files, as the probes are annotated to them. However, if other database is used, the algorithm will only include probes that are mapped to such database.

3.2 CDF file creation

This step can be skipped if the corresponding CDF file is doownloaded from the Dropbox link. The available CDF files were generated using the GTF files for each of the arrays, if users want to generate a CDF for other databases (Ensembl or UCSC), this step should be used.

The function CDFfromGTF generates the CDF file used afterwards in the aroma.affymetrix pre-processing pipeline. Internally, it calls flat2cdf function written by Elizabeth Purdom. More information about it can be seen in the following webpage: Create CDF from scratch

The required input for the function is described below:

  • input : Reference transcriptome. Available options are : “Ensembl”,“UCSC” , “AffyGTF” and “CustomGTF”.
  • inputFile: If input is “AffyGTF” or “CustomGTF”, inputFile should point to the GTF file to be used.
  • PSR: Path to the Exon probes txt file
  • Junc: Path to the Junction probes txt file
  • PathCDF: Directory where the output will be saved
  • microarray: Microarray used to create the CDF file. Must be one of: “HTA-2_0”, “ClariomD”, “RTA” or “MTA”.

This function takes a couple of hours to complete (depending on the computer), and creates the following files:

  1. EventsFound.txt : Tab separated file with all the information of all the alternative splcing events found.
  2. .flat file : Used to build the corresponding CDF file.
  3. .CDF file: Output required for the aroma.affymetrix preprocessing pipeline.

The following code chunks show examples on how to run the function using part of the Affymetrix GTF and the example data included in the package. This data corresponds to the Affymetrix HTA 2.0 GTF representing only the DONSON gene and the probes that are mapped to it.

Using Affymetrix GTF as reference transcriptome


# Set input variables
   PathFiles<-system.file("extdata",package="EventPointer")
   DONSON_GTF<-paste(PathFiles,"/DONSON.gtf",sep="")
   PSRProbes<-paste(PathFiles,"/PSR_Probes.txt",sep="")
   JunctionProbes<-paste(PathFiles,"/Junction_Probes.txt",sep="")
   Directory<-tempdir()
   array<-"HTA-2_0"
   
# Run the function

   CDFfromGTF(input="AffyGTF",inputFile=DONSON_GTF,
              PSR=PSRProbes,Junc=JunctionProbes,
              PathCDF=Directory,microarray=array)
## Creating SG Information...
## Import genomic features from the file as a GRanges object ... OK
## Prepare the 'metadata' data frame ... OK
## Make the TxDb object ... OK
## 
## Reading Information On Probes...Done
## Indexing Genes and Probes...Done
## Finding Events...
## 
  |                                                                         
  |                                                                   |   0%
  |                                                                         
  |===================================================================| 100%
## 
## Creating .flat ...DoneReading TXT file ... Done.
## Splitting TXT file into units ... split into 1 initial chunks ... unwrapped into 8 chunks ... Done.
## Creating structure for 8 units (dot=250):
## 
## Writing CDF file...
##   Pathname: /tmp/Rtmp0Uvzh4/HTA-2_0.cdf
##   Writes CDF header and unit names...
##   Writes CDF header and unit names...done
##   Writes QC units...
##     Units left: 0
##   Writes QC units...done
##   Writes 8 units...
##     Units left: 0
##   Writes 8 units...done
## Writing CDF file...done

Note: Both the .flat and .CDF file take large amounts of space in the hard drive, it is recommended that the directory has at least 1.5 GB of free space.

Figure 3 shows a screen shot with the output of the CDFfromGTF function

Figure 3. Output of CDFfromGTF

Figure 3. Output of CDFfromGTF

Once the file is created, the name of the cdf file can be changed. Internally, the algorithm gives the name as HTA-2_0, but the actual name of the file can be different. In the rest of the vignette, we have renamed our CDF file as EP_HTA-2_0.

Once the CDF file has been created, it can be used for the analysis of different experiments.

3.3 Statistical Analysis

3.3.1 aroma.affymetrix pre-processing pipeline

For microarray data, a pre-processing pipeline must be applied to the .cel files of the experiment. Usually this pre-processing is done using the aroma.affymetrix R package. This procedure normalizes and summarizes the expression of the different probesets into single values.

The aroma.affymetrix R package provides users different functions to work with affymetrix arrays. The functions are used to extract all the information contained in the .cel files and to do all the required pre-processing steps such as background correction, normalization and summarization. The package requires a certain folder structure in order to work correctly. For more information about aroma.affymetrix visit the webpage:aroma project

The following code chunk displays the pipeline used to get the results required by EventPointer after the pre-processing using aroma.affymetrix. The code is not intended to be a runable example, but just to show users the settings and functions that can be used. In order for users to have a runable example, the corrrespoding folder structure and files are required.

# Simple example of Aroma.Affymetrix Preprocessing Pipeline

verbose <- Arguments$getVerbose(-8);
timestampOn(verbose);
projectName <- "Experiment"
cdfGFile <- "EP_HTA-2_0,r"
cdfG <- AffymetrixCdfFile$byChipType(cdfGFile)
cs <- AffymetrixCelSet$byName(projectName, cdf=cdfG)
bc <- NormExpBackgroundCorrection(cs, method="mle", tag=c("*","r11"));
csBC <- process(bc,verbose=verbose,ram=20);
qn <- QuantileNormalization(csBC, typesToUpdate="pm");
csN <- process(qn,verbose=verbose,ram=20);
plmEx <- ExonRmaPlm(csN, mergeGroups=FALSE)
fit(plmEx, verbose=verbose)
cesEx <- getChipEffectSet(plmEx)
ExFit <- extractDataFrame(cesEx, addNames = TRUE)

3.3.2 EventPointer function

EventPointer is the main function of the algorithm

The function requires the following parameters:

  • Design : The design matrix for the experiment.
  • Contrast: The contrast matrix for the experiment.
  • ExFit: [aroma.affymetrix] pre-processed variable after using extractDataFrame(affy, addNames=TRUE)
  • Eventstxt: Path to the EventsFound.txt file generated by CDFfromGTF function.
  • Filter: Boolean variable to indicate if an expression filter is applied.
  • Qn: Quantile used to filter the events (Bounded between 0-1, Q1 would be 0.25).
  • Statistic: Statistical test to identify differential splicing events, must be one of : “LogFC”,“Dif_LogFC” and “DRS”.
  • PSI: Boolean variable to indicate if \(\Delta \Psi\) should be calculated for every splicing event.

If the Filter variable is TRUE, the following is performed:

The summarized expression value of all the reference paths is obtained and the threshold is set depending on the Qn value used.

An event is considered if at least one sample in all paths is expressed above the threshold.

The rest of the events are not shown unless the Filter variable is set to FALSE

   data(ArraysData)

   Dmatrix<-matrix(c(1,1,1,1,0,0,1,1),nrow=4,ncol=2,byrow=FALSE)
   Cmatrix<-t(t(c(0,1)))
   EventsFound<-paste(system.file("extdata",package="EventPointer"),"/EventsFound.txt",sep="")
   
   Events<-EventPointer(Design=Dmatrix,
                      Contrast=Cmatrix,
                      ExFit=ArraysData,
                      Eventstxt=EventsFound,
                      Filter=FALSE,
                      Qn=0.25,
                      Statistic="LogFC",
                      PSI=TRUE)
## 09:34:58 PM Running EventPointer:  
##  ** Statistical Analysis: Logarithm of the fold change of both isoforms 
##  ** Delta PSI will be calculated 
##  ** No expression filter 
##             ---------------------------------------------------------------- 
##  ** Calculating PSI...Done 
##  ** Running Statistical Analysis...Done 
## 
##  09:34:58 PM  Analysis Completed

Table 1 displays the output of EventPointer function


(#tab:EP_Arrays_Res_Table)Table 1: EventPointer Arrays results
Gene name Event Type Genomic Position Splicing Z Value Splicing Pvalue Delta PSI
TC21001058.hg_9 TC21001058.hg Complex Event 21:34951868-34956896 7.16865 0 -0.58198
TC21001058.hg_2 TC21001058.hg Complex Event 21:34954361-34956896 6.82303 0 0.00000
TC21001058.hg_12 TC21001058.hg Complex Event 21:34958487-34960627 6.33509 0 -0.09861
TC21001058.hg_3 TC21001058.hg Complex Event 21:34954552-34956896 6.11308 0 -0.44545
TC21001058.hg_6 TC21001058.hg Complex Event 21:34958487-34960627 -6.08339 0 0.43586

The columns of the data.frame are:

  • Gene name : Gene identifier
  • Event Type: Type of alternative splicing event (Cassette, Alternative 3’,Alternative 5’, Alternative Last Exon, Alternative First Exon, Mutually Exclusive Exons or Complex Event)
  • Genomic Position: Genomic Coordinates for the event
  • Splicing Z Value: Corresponding Z value for the statistical test performed
  • Splicing P Value: Corresponding P-value for the statistical test performed
  • Delta PSI: \(\Delta \Psi\) parameter for each event

3.4 IGV visualization

EventPointer creates two different GTF files to visualize the alternative splicing events. Figure 4 displays the cassette exon for the COPS7A gene (4th ranked event in Table 1). In the IGV visualization, the reference path is shown in gray color, the path 1 in red and path 2 in green. Below the transcripts, the different probes that are measuring each of the paths are represented in the same colors.

Figure 4. EventPointer visualization using IGV

Figure 4. EventPointer visualization using IGV

To create the GTF files, the algorithm uses the EventPointer_IGV functions with the following parameters:

  • Events : Data.frame generated by EventPointer with the events to be included in the GTF file.
  • input: Reference transcriprome. Must be one of: “Ensembl”, “UCSC” , “AffyGTF” or “CustomGTF”.
  • inputFile: If input is “AffyGTF” or “CustomGTF”, inputFile should point to the GTF file to be used.
  • PSR: Path to the Exon probes txt file.
  • Junc: Path to the Junction probes txt file.
  • PathGTF: Directory where to write the GTF files.
  • EventsFile: Path to EventsFound.txt file generated with CDFfromGTF function.
  • microarray: Microarray used to create the CDF file. Must be one of: HTA-2_0, ClariomD, RTA or MTA

The inital process of the function is slow, as the splicing graphs must be created every time the function is executed. A progress bar is displayed to the user to inform about the progress of the function.

Once the process is completed two GTF files are generated in the specified directory:

  1. paths.gtf : GTF file representing the alternative splicing events.
  2. probes.gtf : GTF file representing the probes that measure each event and each path.
Figure 5. GTF files generated with EventPointer_IGV

Figure 5. GTF files generated with EventPointer_IGV


# Set Input Variables
  
   DONSON_GTF<-paste(PathFiles,"/DONSON.gtf",sep="")
   PSRProbes<-paste(PathFiles,"/PSR_Probes.txt",sep="")
   JunctionProbes<-paste(PathFiles,"/Junction_Probes.txt",sep="")
   Directory<-tempdir()
   EventsFound<-paste(system.file("extdata",package="EventPointer"),"/EventsFound.txt",sep="")
   array<-"HTA-2_0"

                      
# Generate Visualization files  

 EventPointer_IGV(Events[1,,drop=FALSE],"AffyGTF",DONSON_GTF,PSRProbes,JunctionProbes,Directory,EventsFound,array)
## Creating SG Information...
## Import genomic features from the file as a GRanges object ... OK
## Prepare the 'metadata' data frame ... OK
## Make the TxDb object ... OK
## 
## Reading Information On Probes...Done
## Indexing Genes and Probes...Done
##  Generating GTF Files...
  |                                                                         
  |                                                                   |   0%
  |                                                                         
  |===================================================================| 100%

3.5 Domain Enrichment

The EventPointer paper states that the algorithm provides a function to identify the protein domains that are affected by alternative splicing using an enrichment analysis.

As we have updated the algorithm, we are currently working on the implementation of this feature in the newer version. As soon as it is implemented, it will be uploaded along with the vignette to show its use.

4 RNA-Seq analysis

EventPointer has two pipelines for RNA-Seq analysis: Analysis from BAM files and analysis from a transcriptome reference. These two pipelines are described in section 4.1 and 4.2.

4.1 Analysis from BAM files

4.1.1 Overview of RNA-Seq

EventPointer is also able to identify alternative splicing events from RNA-Seq data. The only required files are the corresponding .BAM files from the experiment.

Each time an experiment is analyzed with EventPointer, the complete process needs to be executed which may cause long waiting times to get the results. To avoid this issue, we have divided every step of the algorithm in different functions so as the user can reuse previous result and thus reduce computational time.

For the examples in this part of the vignette, we will use .bam files depicted in the SGSeq vignette that correspond to paired-end RNA-seq data from four tumor and four normal colorectal samples, which are part of a data set published in Seshagiri et al. 2012. As stated in SGSeq vignette the bam files only include reads mapping to a single gene of interest (FBXO31).

Note: For sequencing data, there are two requirements for the BAM files in order to get EventPointer working correctly:

  1. The BAM files should include the XS-flag, the flag can be included in the files when running the alignment. Most of the available software has parameters to incude the flag. For example, in the case of STAR the flag –outSAMattributes XS must be included when mapping

  2. All files to be analyzed should have the corresponding index files (.bai) in the same directory as the BAM files. Create the index before running EventPointer.

4.1.2 BAM Preparation

The first step to analyze alternative splicing events in RNA-Seq data, is the creation of the splicing graphs. This step relies entirely on SGSeq R package.

The function PrepareBam_EP transforms all the information found in the bam files into splicing graph features and counts

  • Samples : Name of the .bam files to be analyzed (Sample1.bam,Sample2.bam,…,etc)
  • SamplePath: Path where the bam files are stored
  • Ref_Transc: Reference transcriptome used to name the genes found. Options are: “Ensembl”,“UCSC” or “GTF”.
  • fileTransc: Path to the GTF reference transcriptome if Ref_Transc is “GTF”.
  • cores: Number of cores used for parallel processing
  • Alpha: Internal SGSeq parameter to include or exclude regions (See Advanced Use)
# Obtain the samples and directory for .bam files

# the object si contains example sample information from the SGSeq R package 
# use ?si to see the corresponding documentation 
   
   BamInfo<-si
   Samples<-BamInfo[,2]
   PathToSamples <- system.file("extdata/bams", package = "SGSeq")
   PathToGTF<-paste(system.file("extdata",package="EventPointer"),"/FBXO31.gtf",sep="")

  # Run PrepareBam function
   SG_RNASeq<-PrepareBam_EP(Samples=Samples,
                            SamplePath=PathToSamples,
                            Ref_Transc="GTF",
                            fileTransc=PathToGTF,
                            cores=1)

The output of PrepareBam_EP function is a SGFeaturesCounts object, for more information check SGSeq Vignette. Briefly the SGFeaturesCounts contains a GRanges object with all the required elements to create the different splicing graphs found in the given samples. It also contains the number of counts associated with each element of the splicing graph.

4.1.3 Event Detection

After running PrepareBam_EP, we have all the elements to analyze each of the splicing graphs. The next step is to identify and classify all the events, that are present in the BAM files.

For this purpose, the function EventDetection is used.

  • Input : Output of the PrepareBam_EP function
  • cores: Number of cores used for parallel processing
  • Path: Directory where to write the EventsFound.txt file
  # Run EventDetection function
   data(SG_RNASeq)
   TxtPath<-tempdir()
   AllEvents_RNASeq<-EventDetection(SG_RNASeq,cores=1,Path=TxtPath)
## 
##  Obtaining Events
  |                                                                         
  |                                                                   |   0%
  |                                                                         
  |===========                                                        |  17%
  |                                                                         
  |======================                                             |  33%
  |                                                                         
  |==================================                                 |  50%
  |                                                                         
  |=============================================                      |  67%
  |                                                                         
  |========================================================           |  83%
  |                                                                         
  |===================================================================| 100%

This function retireves a list with all the events found for all the genes present in the experiment. It also generates a file called EventsFound_RNASeq.txt with the information for every detected event.

The list is organized in the following way:

Events[[i]][[j]]

The list will have as many \(i\) values as genes and \(j\) values as many events detected for the \(i_{th}\) gene. In other words, the command above will display the \(j_{th}\) event detected for the \(i_{th}\) gene.

4.1.4 Statistical Analysis

The statistical analysis of the alternative splicing events is done in exactly the same way as for junction arrays. With the Design and Contrast matrices, the algorithm gives the statistical significance and \(\Delta \Psi\).

The function for the statistical analysis using EventPointer method.

  • Events : Output from EventDetection function
  • Design: The design matrix for the experiment.
  • Contrast: The contrast matrix for the experiment.
  • Statistic: Statistical test to identify differential splicing events, must be one of : “LogFC”,“Dif_LogFC” and “DRS”.
  • PSI: Boolean variable to indicate if \(\Delta \Psi\) should be calculated for every splicing event.

The algorithm displays the different parameters that are selected to perform the analysis.

Following our example, the code chunk to obtain the results:

   Dmatrix<-matrix(c(1,1,1,1,1,1,1,1,0,0,0,0,1,1,1,1),ncol=2,byrow=FALSE)
   Cmatrix<-t(t(c(0,1)))
   Events <- EventPointer_RNASeq(AllEvents_RNASeq,Dmatrix,Cmatrix,Statistic="LogFC",PSI=TRUE)
## 09:35:02 PM Running EventPointer:  
##  ** Statistical Analysis: Logarithm of the fold change of both isoforms 
##  ** Delta PSI will be calculated 
##             ---------------------------------------------------------------- 
##  ** Calculating PSI...Done
##  Analysis Finished
##  Done 
## 
##  09:35:02 PM  Analysis Completed

Table 2 displays the output of EventPointer function


(#tab:EP_RNASeq_Res_Table)Table 2: EventPointer RNASeq results
Gene Event_Type Position Pvalue Zvalue Delta PSI
3_17 TC16001330.hg Alternative Last Exon 16:87423454-87445125 0.03439 2.11544 -1.00000
3_6 TC16001330.hg Complex Event 16:87377272-87380780 0.09905 1.64946 -0.02136
3_2 TC16001330.hg Alternative 3’ Splice Site 16:87369063-87369767 0.10470 1.62248 -0.01995
3_7 TC16001330.hg Complex Event 16:87369867-87377343 0.11808 -1.56287 0.00626
3_14 TC16001330.hg Cassette Exon 16:87380856-87393901 0.17744 1.34868 -0.23687

4.1.5 IGV visualization

EventPointer creates one GTF file that can be loaded into IGV to visualize the alternative splicing events. Figure 6 displays an example result showed in IGV (5th ranked event in Table 2). Also, in the figure a reference transcriptome is displayed (blue track), and it can be seen that the displayed event corresponds to a novel event discovered with sequencing data and that it will not be detected using junction arrays.

Figure 6. EventPointer visualization using IGV

Figure 6. EventPointer visualization using IGV

To create the GTF files, the algorithm uses the following code.

  • Events : Data.frame generated by EventPointer_RNASeq with the events to be included in the GTF file.
  • SG_RNASeq: Output from PrepareBam_EP function. Contains splicing graphs components.
  • EventsTxt: Path to EventsFound.txt file generated with EventDetection function
  • PathGTF: Directory where to write the GTF files.

A progress bar is displayed to the user to inform about the progress of the function.

Once the process is completed the GTF file is generated in the specified directory:

  • paths_RNASeq.gtf : GTF file representing the alternative splicing events.

   # IGV Visualization
   EventsTxt<-paste(system.file("extdata",package="EventPointer"),"/EventsFound_RNASeq.txt",sep="")
   PathGTF<-tempdir()
   EventPointer_RNASeq_IGV(Events,SG_RNASeq,EventsTxt,PathGTF)
## 
##  Generating GTF Files...
  |                                                                         
  |                                                                   |   0%
  |                                                                         
  |====                                                               |   6%
  |                                                                         
  |========                                                           |  12%
  |                                                                         
  |============                                                       |  18%
  |                                                                         
  |================                                                   |  24%
  |                                                                         
  |====================                                               |  29%
  |                                                                         
  |========================                                           |  35%
  |                                                                         
  |============================                                       |  41%
  |                                                                         
  |================================                                   |  47%
  |                                                                         
  |===================================                                |  53%
  |                                                                         
  |=======================================                            |  59%
  |                                                                         
  |===========================================                        |  65%
  |                                                                         
  |===============================================                    |  71%
  |                                                                         
  |===================================================                |  76%
  |                                                                         
  |=======================================================            |  82%
  |                                                                         
  |===========================================================        |  88%
  |                                                                         
  |===============================================================    |  94%
  |                                                                         
  |===================================================================| 100%

4.2 Event From Transcriptome Reference

The idea of this pipeline is to apply a statistical analysis to the alternative splicing by using quantification data obtained from kallisto. For this purpose we have to follow the pipeline described in figure 7.

Figure 7. Analysis of RNA-Seq data with kallisto output

Figure 7. Analysis of RNA-Seq data with kallisto output

4.2.1 Event Detection

We use EventGTFfromTrancriptomeGTF to identify and classify alternative splicing events of a given reference transcriptome. The required parameters are:

  • inputFile = inputFile should point to the GTF file to be used.
  • Transcriptome = the name of the transcriptome.
  • Pathtxt = Directory to save the .txt file of the events found.
  • PathGTF = Directory to save the .GTF file of the events found.

Following code shows how to apply EventGTFfromTrancriptomeGTF function using the Gencode 24 transcriptome (GRCH 38) as reference annotation. In this example we do not use the full reference but only two genes (ENSG00000185252.17 and ENSG00000254709.7).



# Set input variables
PathFiles<-system.file("extdata",package="EventPointer")
inputFile <- paste(PathFiles,"/gencode.v24.ann_2genes.gtf",sep="")
Transcriptome <- "Gencode24_2genes"
Pathtxt <- tempdir()
PathGTF <- tempdir()

# Run the function
EventXtrans <- EventsGTFfromTrancriptomeGTF(inputFile = inputFile,
                                           Transcriptome = Transcriptome,
                                           Pathtxt=Pathtxt,
                                           PathGTF=PathGTF)
## Creating SG Information...
## Import genomic features from the file as a GRanges object ... OK
## Prepare the 'metadata' data frame ... OK
## Make the TxDb object ... OK
## 
  |                                                                         
  |                                                                   |   0%
  |                                                                         
  |==================================                                 |  50%
  |                                                                         
  |===================================================================| 100%
## 
## Creating .txt ...
## .txt created
## Creating .GTF ...
  |                                                                         
  |                                                                   |   0%
  |                                                                         
  |=======                                                            |  11%
  |                                                                         
  |===============                                                    |  22%
  |                                                                         
  |======================                                             |  33%
  |                                                                         
  |==============================                                     |  44%
  |                                                                         
  |=====================================                              |  56%
  |                                                                         
  |=============================================                      |  67%
  |                                                                         
  |====================================================               |  78%
  |                                                                         
  |============================================================       |  89%
  |                                                                         
  |===================================================================| 100%
## 
## .txt created
## Creating the sparseMatrix of paths x transcripts...
## 
##  ******FINISHED******

This function takes a couple of hours to complete (depending on the computer), and creates the following files:

  • EventsFound_.txt A .txt file with the information of the events.
  • paths_RNASeq.gtf A .GTF file with the information of the events required to be visualized in IGV.

This function also returns a list containing four elements: three sparce matrices that relate which isoforms build up the paths (path1,path2 and pathRef) of each event. The fourth element contains the name of the reference annotation: only appear the name of the transcript.


names(EventXtrans)
## [1] "ExTP1"          "ExTP2"          "ExTPRef"        "transcritnames"

4.2.2 Quantification

Given the output of EventGTFfromTrancriptomeGTF we can quantify the expression of the alternative splicing events in our experiment as long as the quantification ot the experiment was done in Kallisto using the reference annotation used in EventGTFfromTrancriptomeGTF.

The function GetPSI_FromTranRef obtains the values of \(\Psi\) and needs the following parameters:

  • PathsxTranscript the outpu of EventGTFfromTrancriptomeGTF.
  • Samples A matrix containing the isoform quantification.
  • Filter Boolean variable to indicate if an expression filter is applied. Defaul T.
  • Qn Quantile used to filter the events (Bounded between 0-1, Q1 would be 0.25).

This function also needs that the reference annotation used in Kallisto and in the function EventGTFfromTrancriptomeGTF must be the same. Also in the variable Samples the type of annotation used must be equal to the one used in the variable PathsxTranscript.

In this example we have applied kallisto to the samples ERR315326, ERR315400, ERR315407 and ERR315494 using the same reference used before. These samples have been download from EMBL-EBI dataset.


#first: load data from kallisto output

PathFiles <- system.file("extdata",package="EventPointer")
filesnames <- dir(paste0(PathFiles,"/output"))
PathFiles <- dir(paste0(PathFiles,"/output"),full.names = TRUE)
dirtoload <- paste0(PathFiles,"/","abundance.tsv")
RNASeq <- read.delim(dirtoload[1],sep = "\t", colClasses = c(NA,"NULL","NULL","NULL",NA))
for (n in 2:length(dirtoload)){
  RNASeq[,n+1] <- read.delim(dirtoload[n],sep = '\t', colClasses = c('NULL','NULL','NULL','NULL',NA))
}
rownames(RNASeq)<-RNASeq[,1]
RNASeq<-RNASeq[,-1]
colnames(RNASeq) <- filesnames

#second: the annotation of the transcript names must be equal in RNASeq and PathsxTranscript

rownames(RNASeq) <- sapply(strsplit(rownames(RNASeq),"\\|"),function(X) return(X[1]))
RNASeq<-as.matrix(RNASeq) #must be a matrix variable

#third: Obtain values of PSI
PSIss <- GetPSI_FromTranRef(PathsxTranscript = EventXtrans,Samples = RNASeq,Filter = FALSE)

PSI <- PSIss$PSI
Expression <- PSIss$ExpEvs

The output of the function is a list containing two elements: a matrix with the values of \(\Psi\) and a list containing as many matrices as number of events. In each matrix is stored the expression of the different paths of an event along the samples.

4.2.3 Statistical Analysis

The statistical analysis of the alternative splicing events is done in exactly the same way as for junction arrays and RNA-Seq data from BAM files.

The function EventPointer_RNASeq_TranRef perform this statistical analysis and requires the following parameters:

  • Count_Matrix The list containing the expression data taken from the ouput of GetPSI_FromTranRef
  • Statistic The type of statistic to apply. Default = “LogFC” (can be “logFC,”Dif_LogFC“,”DRS“)
  • Design The design matrix of the experiment.
  • Contrast The Contrast matrix of the experiment.

# Design and contrast matrix:

Design <- matrix(c(1,1,1,1,0,0,1,1),nrow=4)
Contrast <- matrix(c(0,1),nrow=2)

# Statistical analysis:

Fit <- EventPointer_RNASeq_TranRef(Count_Matrix = Expression,Statistic = "LogFC",Design = Design, Contrast = Contrast)
## Done
##  Analysis Finished
##  Done 
## 
##  09:35:08 PM  Analysis Completed

The output of this function is a data.frame with the information of the names of the event, its p.values and the corresponding z.value. If there is more than one contrast, the function returns as many data.frames as number of contrast and all these data.frame are sotred in an unique list.


Table 1: Table 3: PSI_Statistic results
Gen Pvalue ZValue
1 ENSG00000254709.7_3 0.99933 0.00084
2 ENSG00000254709.7_1 0.94801 0.06521
3 ENSG00000185252.17_5 0.98212 0.02241
4 ENSG00000185252.17_15 0.96605 0.04257
5 ENSG00000185252.17_16 0.96605 0.04257
6 ENSG00000185252.17_18 0.21052 -1.25215
7 ENSG00000185252.17_4 0.81371 0.23564
8 ENSG00000185252.17_14 0.80798 0.24304
9 ENSG00000185252.17_17 0.20049 -1.28016

5 Multi-Path Events

EventPointer can also identify Multi-Path events. The multi-path events are composed of more elements than a triplet where the concentration of the reference path should be equal to the sum of the concentration of the rest of paths. This is depicted in Figure 8.

Figure 8. Multi-Path alternative splicing events for EventPointer

Figure 8. Multi-Path alternative splicing events for EventPointer

EventPointer identify Multi-Path events and estimate the percent spliced in value \(\Psi\).

5.1 junctions arrays (CDF file for Multi-Path)

The function CDFfromGTF_Multipath generates the CDF file used afterwards in the aroma.affymetrix preprocesing pipeline. This function is equivalent to the function CDFfromGTF.

The required input for the function is described below:

  • input : Reference transcriptome. Available options are : “Ensembl”,“UCSC” , “AffyGTF” and “CustomGTF”.
  • inputFile: If input is “AffyGTF” or “CustomGTF”, inputFile should point to the GTF file to be used.
  • PSR: Path to the Exon probes txt file
  • Junc: Path to the Junction probes txt file
  • PathCDF: Directory where the output will be saved
  • microarray: Microarray used to create the CDF file. Must be one of: “HTA-2_0”, “ClariomD”, “RTA” or “MTA”.
  • paths: Maximum number of paths of the events to find.

The function CDFfromGTF_Multipath detects events with number of paths from 2 to variable paths. This function classifies the events with two paths as the CDFfromGTF function does and the events with more than two paths as “Multi-Path”.

This function takes a couple of hours to complete (depending on the computer), and creates the same files as the function CDFfromGTF.

The following code chunks show examples on how to run the function using part of the Affymetrix GTF and the example data included in the package. his data corresponds to the Affymetrix HTA 2.0 GTF representing only the DONSON gene and the probes that are mapped to it.

Using Affymetrix GTF as reference transcriptome


# Set input variables
   PathFiles<-system.file("extdata",package="EventPointer")
   DONSON_GTF<-paste(PathFiles,"/DONSON.gtf",sep="")
   PSRProbes<-paste(PathFiles,"/PSR_Probes.txt",sep="")
   JunctionProbes<-paste(PathFiles,"/Junction_Probes.txt",sep="")
   Directory<-tempdir()
   array<-"HTA-2_0"

# Run the function

   CDFfromGTF_Multipath(input="AffyGTF",inputFile=DONSON_GTF,
              PSR=PSRProbes,Junc=JunctionProbes,
              PathCDF=Directory,microarray=array,paths=3)
## Creating SG Information...
## Import genomic features from the file as a GRanges object ... OK
## Prepare the 'metadata' data frame ... OK
## Make the TxDb object ... OK
## 
## Reading Information On Probes...Done
## Indexing Genes and Probes...Done
## Finding Events...
## 
  |                                                                         
  |                                                                   |   0%
  |                                                                         
  |===================================================================| 100%
## 
## Creating .flat ...DoneReading TXT file ... Done.
## Splitting TXT file into units ... split into 1 initial chunks ... unwrapped into 15 chunks ... Done.
## Creating structure for 15 units (dot=250):
## 
## Writing CDF file...
##   Pathname: /tmp/Rtmp0Uvzh4/HTA-2_0.cdf
##   Writes CDF header and unit names...
##   Writes CDF header and unit names...done
##   Writes QC units...
##     Units left: 0
##   Writes QC units...done
##   Writes 15 units...
##     Units left: 0
##   Writes 15 units...done
## Writing CDF file...done

##RNA-Seq (Event detection for Multi-Path)

As for two-paths events, the only required files are the corresponding .BAM files from the experiment. After the BAM Preparation step explained in section 4.2 we have all the elements needed to analyze each of the splicing graphs. To detect Multi-Path events, the function EventDetectionMultipath is used.

This function requires the following parameters:

  • Input : Output of the PrepareBam_EP function
  • cores: Number of cores used for parallel processing
  • Path: Directory where to write the EventsFound.txt file
  • paths: Maximum number of paths of the events to find.

The function EventDetectionMultipath detects events with number of paths from 2 to variable paths. This function classifies the events with two paths as the EventDetection function does and the events with more than two paths as “Multi-Path”.

  # Run EventDetection function
   data(SG_RNASeq)
   TxtPath<-tempdir()
   AllEvents_RNASeq_MP<-EventDetectionMultipath(SG_RNASeq,cores=1,Path=TxtPath,paths=3)
## 
##  Obtaining Events
  |                                                                         
  |                                                                   |   0%
  |                                                                         
  |===========                                                        |  17%
  |                                                                         
  |======================                                             |  33%
  |                                                                         
  |==================================                                 |  50%
  |                                                                         
  |=============================================                      |  67%
  |                                                                         
  |========================================================           |  83%
  |                                                                         
  |===================================================================| 100%

This function retireves a list with all the events found for all the genes present in the experiment. It also generates a file called EventsFound_RNASeq.txt with the information for every detected event.

The list is organized in the following way:

Events[[i]][[j]]

The list will have as many \(i\) values as genes and \(j\) values as many events detected for the \(i_{th}\) gene. In other words, the command above will display the \(j_{th}\) event detected for the \(i_{th}\) gene.

6 Advanced Use

6.1 Statistical Tests

EventPointer provides three different statistical tests that can be used to determine the statistical significance to the alternative splicing events.

In Table 5, the most relevatn coefficients from the statistical and events information point of view are shown

Table 5. Coefficients of the linear model used to detect alternative splicing

Table 5. Coefficients of the linear model used to detect alternative splicing

There are a number of alternatives to detect AS using these coefficients. Either of \(\beta_4\) , \(\beta_5\) , \(\beta_4\) + \(\beta_5\) is theoretically able to detect AS events. Some of them are more sensitive than others depending on the relative concentrations of the isoforms. For example, if isoform 2 is much more highly expressed than isoform 1 in both conditions, \(\beta_4\) will be more sensitive than \(\beta_4\) + \(\beta_5\) since in the latter case, the numerator and denominator of the logarithms of both terms are similar, and hence their logs are close to zero.

A contrast on \(\beta_5\) would seem to be more sensitive than a contrast on \(\beta_4\) or \(\beta_4\) + \(\beta_5\) ; however, in practice, this contrast proved to be “too sensitive” and led to many false positives especially in weakly expressed isoforms. If one of the paths is not expressed in any condition, its signal will be similar in either condition (the background level) and a change in the expression of the other isoform will drive to a false positive detection. This contrast can be used only if the signals are filtered to guarantee that they are above the background.

In the PCR validation, the contrast that provided the best performance was the combination of the fold changes of both isoforms (i.e. \(\beta_3\) + \(\beta_4\) and \(\beta_3\)+\(\beta_4\) + \(\beta_5\) in Table 4) plus the requirement that the fold-changes have opposite directions, i.e. if isoform 1 significantly increases its expression, isoform 2 must significantly decrease its expression and vice versa. Therefore, if this test requires that the detected AS events show a significant change of the expression both paths and this change must be in opposite direction.

In order to compute this contrast, we summed up the p-values (one-tailed) for both contrasts. If the null hypothesis holds, the expected null distribution is triangular from 0 to 2 with the peak at 1, and the summation of the p-values must be close to 0 or close to 2 for genes with differential AS. Using this triangular distribution, it is possible to assign an overall p-value to their sum. We preferred this combination rather than the classical Fisher method since in the latter a single good p-value yields a good summary p-value for the event. Using this approach, both p-values must be close to zero or one in order to generate a significant overall p-value.

The different options availabe in EventPointer are:

1. LogFC : Compute the contrast using \(\beta_3\) + \(\beta_4\) and \(\beta_3\)+\(\beta_4\) + \(\beta_5\)

2. Dif_LogFC : Compute the contrast using \(\beta_4\) and \(\beta_4\) + \(\beta_5\)

3. DRS: Compute the constast using \(\beta_5\)

6.2 Alpha parameter for PrepareBam_EP function

Alpha is a parameter used by SGSeq R package to predict the features that are along the different bam files that are being analyzed. As stated in the help menu for the predictTxtFeatures function:

Alpha Minimum FPKM required for a splice junction to be included.

The user can change the value to be more or less restrictive when deciding if a feature is included or not. As the alpha value increases, the algorithm will slow down as the splicing graphs would became more complex.

6.3 Percent Spliced In

EventPointer estimates the abundance of the isoforms mapped to each of the paths, in an splicing event, to obtain the PSI values. With this values, a simple linear model, using the provided design and contrast matrices, is solved and this increment is returned to the user in the data.frame (if PSI argument is TRUE).

It is possible to obtain the estimated PSI values using the internal functions getPSI,getPSImultipath for junction arrays, getPSI_RNASeq or getPSI_RNASeq_MultiPath for RNA-Seq data (data from the pipeline described in section 4.2: statistical analysis from de BAM files).

These functions not only calculate the value of \(\Psi\) but also the residuals of the simple linear model used to estimate the values of \(\Psi\).


# Microarrays (two paths)
data(ArraysData)
PSI_Arrays_list<-EventPointer:::getPSI(ArraysData)
PSI_Arrays <- PSI_Arrays_list$PSI
Residuals_Arrays <- PSI_Arrays_list$Residuals

# Microarrays (Multi-Path)
data(ArrayDatamultipath)
PSI_MP_Arrays_list <- EventPointer:::getPSImultipath(ArrayDatamultipath)
PSI_multipath_Arrays <- PSI_MP_Arrays_list$PSI
Residuals_multipath_Arrays <- PSI_MP_Arrays_list$Residuals

# RNASeq (two paths)
data(AllEvents_RNASeq)
PSI_RNASeq_list<-EventPointer:::getPSI_RNASeq(AllEvents_RNASeq)
PSI_RNASeq <- PSI_RNASeq_list$PSI
Residuals_RNASeq <- PSI_RNASeq_list$Residuals

# RNASeq (Multi-Path)
data(AllEvents_RNASeq_MP)
PSI_MP_RNASeq_list <- EventPointer:::getPSI_RNASeq_MultiPath(AllEvents_RNASeq_MP)
PSI_multipath_RNASeq <- PSI_MP_RNASeq_list$PSI
Residuals_multipath_RNASeq <- PSI_MP_RNASeq_list$Residuals

We can apply the function PSI_Statistic described in section 4.2.2 to the values of \(\Psi\) (only for two-paths events).


Dmatrix<-matrix(c(1,1,1,1,0,0,1,1),nrow=4,ncol=2,byrow=FALSE)
Cmatrix<-t(c(0,1))

table <- PSI_Statistic(PSI = PSI_Arrays,Design = Dmatrix,Contrast = Cmatrix,nboot = 20)

The residual obtained in the linear model used to estimate the values of \(\Psi\) must be independent from the Design matrix of the experiment. The data of the residuals that returns the internal functions getPSI or getPSI_RNASeq are useful to validate if this is true. The next code shows an example of how to perform a statistical analysis of the residuals.


Dmatrix<-matrix(c(1,1,1,1,0,0,1,1),nrow=4,ncol=2,byrow=FALSE)
Cmatrix<-t(t(c(0,1)))

Ress <- vector("list", length = ncol(Cmatrix))

fitresiduals <- limma::lmFit(Residuals_Arrays,design = Dmatrix)
fitresiduals2 <- limma::contrasts.fit(fitresiduals, Cmatrix)
fitresiduals2 <- limma::eBayes(fitresiduals2)

# repeated if there is more than one contrast
for (jj in 1:ncol(Cmatrix)) {
  TopPSI <- limma::topTable(fitresiduals2, coef = jj, number = Inf)[, 1, drop = FALSE]
  colnames(TopPSI)<-"Residuals"
  Ress[[jj]] <- TopPSI
}

7 References

8 Session Information

sessionInfo()
## R version 3.5.1 Patched (2018-07-12 r74967)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 16.04.5 LTS
## 
## Matrix products: default
## BLAS: /home/biocbuild/bbs-3.8-bioc/R/lib/libRblas.so
## LAPACK: /home/biocbuild/bbs-3.8-bioc/R/lib/libRlapack.so
## 
## locale:
##  [1] LC_CTYPE=en_US.UTF-8       LC_NUMERIC=C              
##  [3] LC_TIME=en_US.UTF-8        LC_COLLATE=C              
##  [5] LC_MONETARY=en_US.UTF-8    LC_MESSAGES=en_US.UTF-8   
##  [7] LC_PAPER=en_US.UTF-8       LC_NAME=C                 
##  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
## [11] LC_MEASUREMENT=en_US.UTF-8 LC_IDENTIFICATION=C       
## 
## attached base packages:
## [1] stats4    parallel  stats     graphics  grDevices utils     datasets 
## [8] methods   base     
## 
## other attached packages:
##  [1] EventPointer_2.0.1          Matrix_1.2-15              
##  [3] SGSeq_1.16.0                SummarizedExperiment_1.12.0
##  [5] DelayedArray_0.8.0          BiocParallel_1.16.2        
##  [7] matrixStats_0.54.0          Biobase_2.42.0             
##  [9] Rsamtools_1.34.0            Biostrings_2.50.1          
## [11] XVector_0.22.0              GenomicRanges_1.34.0       
## [13] GenomeInfoDb_1.18.1         IRanges_2.16.0             
## [15] S4Vectors_0.20.1            BiocGenerics_0.28.0        
## [17] knitr_1.20                  BiocStyle_2.10.0           
## 
## loaded via a namespace (and not attached):
##  [1] bitops_1.0-6             bit64_0.9-7             
##  [3] doParallel_1.0.14        progress_1.2.0          
##  [5] httr_1.3.1               rprojroot_1.3-2         
##  [7] tools_3.5.1              backports_1.1.2         
##  [9] R6_2.3.0                 DBI_1.0.0               
## [11] lazyeval_0.2.1           colorspace_1.3-2        
## [13] tidyselect_0.2.5         prettyunits_1.0.2       
## [15] bit_1.1-14               compiler_3.5.1          
## [17] graph_1.60.0             quantreg_5.36           
## [19] SparseM_1.77             rtracklayer_1.42.1      
## [21] bookdown_0.8             scales_1.0.0            
## [23] nnls_1.4                 RBGL_1.58.1             
## [25] stringr_1.3.1            digest_0.6.18           
## [27] rmarkdown_1.10           pkgconfig_2.0.2         
## [29] htmltools_0.3.6          highr_0.7               
## [31] limma_3.38.3             rlang_0.3.0.1           
## [33] RSQLite_2.1.1            bindr_0.1.1             
## [35] dplyr_0.7.8              RCurl_1.95-4.11         
## [37] magrittr_1.5             GenomeInfoDbData_1.2.0  
## [39] Rhdf5lib_1.4.2           Rcpp_1.0.0              
## [41] munsell_0.5.0            stringi_1.2.4           
## [43] yaml_2.2.0               MASS_7.3-51.1           
## [45] zlibbioc_1.28.0          rhdf5_2.26.0            
## [47] plyr_1.8.4               qvalue_2.14.0           
## [49] grid_3.5.1               affxparser_1.54.0       
## [51] blob_1.1.1               crayon_1.3.4            
## [53] lattice_0.20-38          splines_3.5.1           
## [55] GenomicFeatures_1.34.1   hms_0.4.2               
## [57] pillar_1.3.0             igraph_1.2.2            
## [59] RUnit_0.4.32             reshape2_1.4.3          
## [61] codetools_0.2-15         biomaRt_2.38.0          
## [63] glue_1.3.0               XML_3.98-1.16           
## [65] evaluate_0.12            cobs_1.3-3              
## [67] BiocManager_1.30.4       foreach_1.4.4           
## [69] MatrixModels_0.4-1       purrr_0.2.5             
## [71] gtable_0.2.0             assertthat_0.2.0        
## [73] ggplot2_3.1.0            xfun_0.4                
## [75] prodlim_2018.04.18       survival_2.43-3         
## [77] tibble_1.4.2             iterators_1.0.10        
## [79] GenomicAlignments_1.18.0 AnnotationDbi_1.44.0    
## [81] memoise_1.1.0            bindrcpp_0.2.2          
## [83] lava_1.6.4