Learn R Programming

gCMAP (version 1.16.0)

Tools for Connectivity Map-like analyses

Description

The gCMAP package provides a toolkit for comparing differential gene expression profiles through gene set enrichment analysis. Starting from normalized microarray or RNA-seq gene expression values (stored in lists of ExpressionSet and CountDataSet objects) the package performs differential expression analysis using the limma or DESeq packages. Supplying a simple list of gene identifiers, global differential expression profiles or data from complete experiments as input, users can use a unified set of several well-known gene set enrichment analysis methods to retrieve experiments with similar changes in gene expression. To take into account the directionality of gene expression changes, gCMAPQuery introduces the SignedGeneSet class, directly extending GeneSet from the GSEABase package. To increase performance of large queries, multiple gene sets are stored as sparse incidence matrices within CMAPCollection eSets. gCMAP offers implementations of 1. Fisher's exact test (Fisher, J R Stat Soc, 1922) 2. The "connectivity map" method (Lamb et al, Science, 2006) 3. Parametric and non-parametric t-statistic summaries (Jiang & Gentleman, Bioinformatics, 2007) and 4. Wilcoxon / Mann-Whitney rank sum statistics (Wilcoxon, Biometrics Bulletin, 1945) as well as wrappers for the 5. camera (Wu & Smyth, Nucleic Acid Res, 2012) 6. mroast and romer (Wu et al, Bioinformatics, 2010) functions from the limma package and 7. wraps the gsea method from the mgsa package (Bauer et al, NAR, 2010). All methods return CMAPResult objects, an S4 class inheriting from AnnotatedDataFrame, containing enrichment statistics as well as annotation data and providing simple high-level summary plots.

Copy Link

Version

Version

1.16.0

License

Artistic-2.0

Maintainer

Last Published

February 15th, 2017

Functions in gCMAP (1.16.0)

CMAPResults-class

Class "CMAPResults"
connectivity_score

Broad CMAP gene set enrichment metrics
induceCMAPCollection-methods

Methods for Function induceCMAPCollection in Package gCMAP
KEGG2cmap

pairwise_DESeq

Generate statistics associated with pairwise differential expression from RNAseq count data
annotate_eset_list

camera_score-methods

Methods for Function camera_score in Package gCMAP
generate_gCMAP_NChannelSet

Generate a perturbation profile library from expression sets of control/treatment pairs
GeneSet

Methods for GeneSet and GeneColorSet
mgsa_score-methods

Model-based gene set analysis (MGSA)
minSetSize-methods

GeneSetCollection length filtering
romer_score-methods

Methods for Function romer_score in Package gCMAP
wilcox_score-methods

Methods for Function wilcox_score in Package gCMAP
zScores

Function to calculate z-scores from p-values
mapNmerge

A function to map eSet featureNames and calculate summaries for many-to-one mapping features
matrix_or_big.matrix-class

Class "matrix_or_big.matrix"
eSetOnDisk

A function to store the assayData of an eSet object as BigMatrix files on disk.
featureScores-methods

Methods to obtain scores for CMAPCollection gene sets from a matrix or eSet
fisher_score-methods

Hypergeometric probability of gene set enrichment
gCMAP-package

Tools for Connectivity Map-like analyses
pairwise_compare

Generate statistics associated with pairwise differential expression
mroast_score-methods

Methods for Function mroast_score in Package gCMAP
SignedGeneSet-class

Class "SignedGeneSet"
SignedGeneSet

Construtor for SignedGeneSet
center_eSet

A function to to center columns of eSet channels on either their kernel density peak, their mean or their median.
CMAPCollection-class

Class "CMAPCollection"
gsealm_score-methods

Methods for Function gsealm_score in Package gCMAP
memorize

Create a new NChannelSet instance by selecting specific channels and load BigMatrix assayData into memory.
gsealm_jg_score-methods

Parametric test for testing normally distributed scores for gene set enrichment
mergeCMAPs

This function merged two eSets.
eset_instances

A function to subset an eSet with expression data into smaller datasets, each corresponding to a single perturbation experiment.
DESeq_nbinom

Function to perform a DESeq analysis to detect differential expression between perturbation and control groups.
gCMAPData

Example NChannelSet
geneIndex-methods

Methods for Function geneIndex in Package gCMAP
signedRankSumTest

An implementation of the Wilcox rank sum test / Mann-Whitney test that takes into account the direction / sign of gene set members and possibly the correlation between cases
splitPerturbations

Function to split an ExpressionSet downloaded from ArrayExpress based on the experimental factors present in the phenoData slot