Unlimited learning, half price | 50% off
Get 50% off unlimited learning

casper (version 2.6.0)

Characterization of Alternative Splicing based on Paired-End Reads

Description

Infer alternative splicing from paired-end RNA-seq data. The model is based on counting paths across exons, rather than pairwise exon connections, and estimates the fragment size and start distributions non-parametrically, which improves estimation precision.

Copy Link

Version

Version

2.6.0

License

GPL (>=2)

Maintainer

David Rossell

Last Published

February 15th, 2017

Functions in casper (2.6.0)

denovoGeneExpr-class

Class "denovoGeneExpr"
calcDenovo

Estimate expression of gene splicing variants de novo.
splitGenomeByLength

Split an annotatedGenome object into subsets according to gene length
modelPrior

Set prior distribution on expressed splicing variants.
mergeBatches

Merge two ExpressionSet objects by doing quantile normalization and computing partial residuals (i.e. substracting group mean expression in each batch). As currently implemented the method is only valid for balanced designs, e.g. each batch has the same number of samples per group.
asymmetryCheck

Plot asymmetry coefficients for the observed data and compare to those expected under Normality.
getRoc

Operating characteristics of differential expression analysis
subsetGenome

subsetGenome subsets an object of class annotatedGenome for a set of island IDs or chromosome names.
denovoGenomeExpr-class

Class "denovoGenomeExpr"
getNreads

Get total number of paths in each island from a pathCounts object.
simMAEcheck

Model checking for One Sample Problems.
denovoExpr

Estimate expression for de novo splicing variants.
wrapKnown

Run all necessary steps to get expression estimates from multiple bam files with the casper pipeline.
plotPriorAS

Plot prior distribution on set of expressed variants (i.e. the model space).
annotatedGenome-class

Class "annotatedGenome"
probNonEquiv

probNonEquiv performs a Bayesian hypothesis test for equivalence between group means. It returns the posterior probability that |mu1-mu2|>logfc. pvalTreat is a wrapper to treat in package limma, which returns P-values for the same hypothesis test.
procBam

Process BAM object
hg19DB

Subset of human genome (UCSC hg19 version)
txLength

~~ Methods for Function txLength in Package casper ~~
simMAE

Simulate Mean Absolute Error (MAE) in estimating isoform expression under various experimental settings.
transcripts

Extracts transcript information (exon start and ends) from an annotatedGenome object, either for all transcripts or only those corresponding to a given island or transcript.
mergeExp

Merge splicing variant expression from multiple samples
getIsland

getIsland returns the island id associated to a given entrez or transcript id in an annotatedGenome object. getChr indicates the chromosome for a given Entrez, transcript or island id.
relexprByGene

Compute relative expressions within each gene
getDistrs

Compute fragment start and fragment length distributions
pathCounts

Compute exon path counts
qqnormGenomeWide

Genome-wide qq-normal and qq-gamma plots
pathCounts-class

Class "pathCounts"
plot-methods

Plot estimated read start and fragment length distributions.
procBam-class

Class "procBam"
modelPriorAS-class

Class "modelPriorAS"
genePlot

Plot exon structure for each transcript of a given gene.
simReads

Function to simulate paired end reads following given read start and fragment length distributions and gene and variant expressions.
wrapDenovo

Run all necessary steps to get expression estimates from multiple bam files with the casper pipeline.
distrsGSE37704

Estimated read start and insert size distributions from MiSeq data in GEO dataset GSE37704.
plotExpr

Plot inferred gene structure and expression.
procGenome

Create an annotatedGenome object that stores information about genes and transcripts
rmShortInserts

Remove reads with short insert sizes from imported BAM files.
K562.r1l1

Toy RNA-seq data from RGASP project.
getReads

getReads returns the reads stored in a procBam object.
calcExp

Estimate expression of a known set of gene splicing variants.
simMultSamples

Simulate paired end reads for multiple future samples based on pilot data, and obtain their expression estimates via casper
simulatedSamples-class

Class "simulatedSamples"
quantileNorm

Apply quantile normalization