Title: | Comparison between multiple levels of gene expression |
---|---|
Description: | Detection of differentially expressed genes (DEGs) from the comparison of two biological conditions (treated vs. untreated, diseased vs. normal, mutant vs. wild-type) among different levels of gene expression (transcriptome ,translatome, proteome), using several statistical methods: Rank Product, Translational Efficiency, t-test, Limma, ANOTA, DESeq, edgeR. Possibility to plot the results with scatterplots, histograms, MA plots, standard deviation (SD) plots, coefficient of variation (CV) plots. Detection of significantly enriched post-transcriptional regulatory factors (RBPs, miRNAs, etc) and Gene Ontology terms in the lists of DEGs previously identified for the two expression levels. Comparison of GO terms enriched only in one of the levels or in both. Calculation of the semantic similarity score between the lists of enriched GO terms coming from the two expression levels. Visual examination and comparison of the enriched terms with heatmaps, radar plots and barplots. |
Authors: | Toma Tebaldi, Erik Dassi, Galena Kostoska |
Maintainer: | Toma Tebaldi <[email protected]>, Erik Dassi <[email protected]> |
License: | GPL-3 |
Version: | 1.45.0 |
Built: | 2024-10-31 06:25:24 UTC |
Source: | https://github.com/bioc/tRanslatome |
Description: Detection of differentially expressed genes (DEGs) from the comparison of two biological conditions (treated vs. untreated, diseased vs. normal, mutant vs. wild-type) among different levels of gene expression (transcriptome ,translatome, proteome), using several statistical methods: Translational Efficiency, Rank Product, t-test, Limma, ANOTA, DESeq, edgeR. Possibility to plot the results with scatterplots, histograms, MA plots, standard deviation (SD) plots, coefficient of variation (CV) plots. Detection of significantly enriched Gene Ontology terms in the lists of DEGs previously identified for the two expression levels. Comparison of GO terms enriched only in one of the levels or in both. Calculation of the semantic similarity score between the lists of enriched GO terms coming from the two expression levels. Visual examination and comparison of the GO terms with heatmaps, radar plots and barplots.
This function displays an object of class character
specifying the names of the two levels compared in the experiment. It takes as input an object of class GOsims
.
average.similarity.scores(object)
average.similarity.scores(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
data(tRanslatomeSampleData) average.similarity.scores(CCComparison)
data(tRanslatomeSampleData) average.similarity.scores(CCComparison)
This function takes as input an object of the class TranslatomeDataset
which contains a normalized data matrix coming from high throughput experiment.
It takes as an input a character label specifying the method that we want to employ in order to detect DEGs(t-test, translational efficiency, ANOTA, DESeq, edgeR, RP, limma) and returns an object of the class DEGs
, in which each gene is assigned an expression class: up- or down-regulated at the first level, up- or down-regulated at the second level, up-regulated at both levels, down-regulated at both levels, up-regulated at the first level and down-regulated at the second level and vice versa.
computeDEGs(object, method="limma", significance.threshold= 0.05, FC.threshold= 0, log.transformed = FALSE, mult.cor=TRUE)
computeDEGs(object, method="limma", significance.threshold= 0.05, FC.threshold= 0, log.transformed = FALSE, mult.cor=TRUE)
object |
an object of class |
method |
a character string that specifies the method that the user wants to employ in the differential expression analysis. It can have one the following values: |
significance.threshold |
a numeric value specifying the threshold on the statistical significance below which the genes are considered as differentially expressed, the default is set to |
FC.threshold |
a numeric value specifying the threshold on the absolute log2 fold change, above which the genes are considered as differentially expressed, the default is set to |
log.transformed |
a boolean variable specifying whether the signals contained in expr.matrix have been previously log2 transformed. By default it is set to |
mult.cor |
a boolean variable specifying whether the significance threshold is applied on the multiple test corrected or on the original p-values obtained from the DEGs detection method. By default it is set to |
Signals contained in expr.matrix should be previously normalized with standard methods (quantile, percentile shift, ... ) when data is coming from microarrays or in the appropriate cases when it is coming from sequencing experiments.
An object of class DEGs
Toma Tebaldi, Erik Dassi, Galena Kostoska
Smyth GK. (2004) Linear models and empirical Bayes methods for assessing differential expression in microarray experiments. Stat Appl Genet Mol Biol., 3:Article3.
Tian L, Greenberg SA, Kong SW, Altschuler J, Kohane IS, Park PJ.(2005) Discovering statistically significant pathways in expression profiing studies. Proc Natl Acad Sci USA, 102(38):13544-9.
Courtes FC et al. (2013) Translatome analysis of CHO cells identify key growth genes. Journal of Biotechnology, 167, 215-24.
Breitling R, Armengaud P, Amtmann A, Herzyk P.(2004) Rank products: a simple, yet powerful, new method to detect differentially regulated genes in replicated microarray experiments. FEBS Lett., 573(1-3):83-92.
Tusher VG, Tibshirani R, Chu G.(2001) Significance analysis of microarrays applied to the ionizing radiation response. Proc Natl Acad Sci USA., 2001, 98(9):5116-21.
Larsson O, Sonenberg N, Nadon R.(2011) anota: Analysis of differential translation in genome-wide studies. Bioinformatics, 27(10):1440-1.
Anders S, Huber W.(2010) Differential expression analysis for sequence count data. Genome Biology, 11(10):R106.
Robinson MD, McCarthy DJ, Smyth GK.(2010) edgeR: a Bioconductor package for differential expression analysis of digital gene expression data. Bioinformatics, 26(1):139-40.
TranslatomeDataset
DEGs
Scatterplot
Histogram
CVplot
MAplot
SDplot
data(tRanslatomeSampleData) computeDEGs(translatome.analysis, method= "limma", ,mult.cor=TRUE)
data(tRanslatomeSampleData) computeDEGs(translatome.analysis, method= "limma", ,mult.cor=TRUE)
The CV plot displays the coefficients of variation of the genes on the x-axis and the log2 fold changes on the y-axis. The upper plot represents a CV plot for the first level of gene expression analysis, whereas the other one refers to the second level. DEGs are color labeled. This function takes as input an object of class DEGs
.
CVplot(object, outputformat="on screen",track="")
CVplot(object, outputformat="on screen",track="")
object |
an object of class |
outputformat |
a character string specifying if the plot is saved in jpeg ( |
track |
a character vector of gene names that will be explicitly highlighted in the scatterplot, if they match any gene contained in the object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
DEGs
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) CVplot(limma.DEGs, outputformat="on screen",track=c("BLM"))
data(tRanslatomeSampleData) CVplot(limma.DEGs, outputformat="on screen",track=c("BLM"))
DEGs
A class generated from the function computeDEGs()
containing the result of the differential expression analysis at the two expression levels.
DEGs.table
:Object of class matrix
containing all the differential expression analysis. The matrix contains one row for each gene, while columns are organized as follows:
log2 FC(1st level)
, log2 fold change in the first level,
avg(1st level,control)
, average signal intensities of the control samples in the first level,
sd(1st level,control)
, standard deviation of the signal intensities of the control samples in the first level,
avg(1st level,treated)
, average signal intensities of the treated samples in the first level,
sd(1st level,treated)
, standard deviation of the signal intensities of the treated samples in the first level,
pv.METHOD(1st level)
, the differential expression p-value returned from the chosen method in the first level (the name of this column will change according to the selected method),
pv.METHOD.BH(1st level)
, the Benjamini-Hochberg corrected differential expression p-value returned from the chosen method in the first level (the name of this column will change according to the selected method),
log2 FC(2nd level)
, log2 fold change in the second level,
avg(2nd level,control)
, average signal intensities of the control samples in the second level,
sd(2nd level,control)
, standard deviation of the signal intensities of the control samples in the second level,
avg(2nd level,treated)
, average signal intensities of the treated samples in the second level,
sd(2nd level,treated)
, standard deviation of the signal intensities of the treated samples in the second level,
pv.METHOD(2nd level)
, the differential expression p-value returned from the chosen method in the second level (the name of this column will change according to the selected method),
pv.METHOD.BH(2nd level)
, the Benjamini-Hochberg corrected differential expression p-value returned from the chosen method in the second level (the name of this column will change according to the selected method),
level1Up
, boolean value set to 1 if the gene is upregulated in the first level, otherwise set to 0,
level1Down
, boolean value set to 1 if the gene is downregulated in the first level, otherwise set to 0,
level2Up
, boolean value set to 1 if the gene is upregulated in the second level, otherwise set to 0,
level2Down
, boolean value set to 1 if the gene is downregulated in the second level, otherwise set to 0,
DownDown
, boolean value set to 1 if the gene is downregulated in both levels, otherwise set to 0,
DownUp
, boolean value set to 1 if the gene is downregulated in the first level and up regulated in the second level, otherwise set to 0,
UpDown
, boolean value set to 1 if the gene is upregulated in the first level and downregulated in the second level, otherwise set to 0,
UpUp
, boolean value set to 1 if the gene is upregulated in both levels, otherwise set to 0
method
:Object of class character
specifying the statistical method used to detect DEGs.
significance.threshold
:Object of class numeric
specifying the significance threshold used to detect DEGs.
FC.threshold
:Object of class numeric
specifying the fold change threshold used to detect DEGs.
label.level.DEGs
:Object of class character
specifying the names of the two levels compared in the experiment.
label.condition
:Object of class character
specifying the names of the two conditions compared in the experiment.
signature(object = "DEGs")
: displays an object of class character
specifying the statistical method used to detect DEGs.
signature(object = "DEGs")
: displays an object of class numeric
specifying the significance threshold used to detect DEGs.
signature(object = "DEGs")
: displays an object of class numeric
specifying the fold change threshold used to detect DEGs.
signature(object = "DEGs")
: displays an object of class character
specifying the names of the two levels compared in the experiment.
signature(object = "DEGs")
: displays an object of class character
specifying the names of the two conditions compared in the experiment.
signature(object = "DEGs")
: displays an object of class matrix
specifying the table of computed DEGs.
signature(object = "DEGs")
: enables the generation of a plot where, for each level, signal coefficients of variation for each gene are displayed against their log2 fold changes. DEGs are color labeled.
signature(object = "DEGs")
: enables the GO enrichment analysis of the differentially expressed genes at each level.
signature(object = "DEGs")
: enables the enrichment analysis of post-transcriptional regulators (RBPs, miRNAs, ecc) in the DEGs gene list, by means of Fisher test.
signature(object = "DEGs")
: enables the generation of a histogram displaying the number of DEGs belonging to different classes according to their expression behaviour at the two levels.
signature(object = "DEGs")
: enables the generation of a plot where, for each level, average signal intensities for each gene are displayed against their log2 fold changes. DEGs are color labeled.
signature(object = "DEGs")
: enables the generation of a plot where fold changes at the first level are displayed for each gene against fold changes at the second level. DEGs are color labeled.
signature(object = "DEGs")
: enables the generation of a plot where, for each level, signal standard deviations for each gene are displayed against their log2 fold changes. DEGs are color labeled.
signature(object = "DEGs")
: displays all the six slots of the class.
Toma Tebaldi, Erik Dassi, Galena Kostoska
TranslatomeDataset
computeDEGs
RegulatoryEnrichment
GOEnrichment
EnrichedSets
GOsets
showClass("DEGs")
showClass("DEGs")
This function displays an object of class numeric
specifying the significance threshold used to detect DEGs. It takes as input an object of class DEGs
.
DEGs.table(object)
DEGs.table(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
DEGs
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) DEGs.table(limma.DEGs)
data(tRanslatomeSampleData) DEGs.table(limma.DEGs)
This function displays an object of class character
specifying the names of the two levels compared in the experiment. It takes as input an object of class EnrichedSets
.
enriched.table(object)
enriched.table(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
data(tRanslatomeSampleData) enriched.table(CCEnrichment)
data(tRanslatomeSampleData) enriched.table(CCEnrichment)
EnrichedSets
A class generated from the function RegulatoryEnrichment()
containing the overrepresented post-transcriptional regulatory factors (RBPs, miRNAs, etc) from the lists of differentially expressed genes coming from the analysis of two different expression levels.
enriched.table
:Object of class data.frame
containing all the regulatory enrichment analysis. The data frame contains one row for each regulatory factor, while columns are organized as follows:
level
, level of analysis on which the enrichment is calculated. The names of the two levels are taken from the object DEGs
given as an input to the function GOEnrichment
.
ID
, ID of the regulatory factor.
number
, number of genes in the human genome associated to the regulatory factor.
list
, list of genes in the list of DEGs associated to the regulatory factor.
pv.fisher
, enrichment p-value calculated with the Fisher test.
pv.fisher.BH
, the Benjamini-Hochberg corrected enrichment p-value calculated with the Fisher test according to the chosen enrichment method.
label.level.enriched
:Object of class character
specifying the names of the two levels compared in the experiment.
signature(object = "EnrichedSets")
: displays the slot enriched.table
.
signature(object = "EnrichedSets")
: displays the slot label.level.enriched, slot of class character
specifying the names of the two levels compared in the experiment.
signature(object = "EnrichedSets")
: enables the generation of a heatmap of the top enriched regulatory factors for the first and second level of analysis.
signature(object = "EnrichedSets")
: displays the slot label.level.enriched
.
signature(object = "EnrichedSets")
: enables the generation of a radar plot of the top enriched regulatory factors for the first and second level of analysis.
signature(object = "EnrichedSets")
: displays all the two slots of the class.
Erik Dassi, Toma Tebaldi
Alexa A, Rahnenfuhrer J, Lengauer T. Improved scoring of functional groups from gene expression data by decorrelating go graph structure. Bioinformatics 2006, 22(13):1600-7. Dassi E et al(2012). AURA: Atlas of UTR Regulatory Activity. Bioinformatics. 28(1):142-4.
showClass("EnrichedSets")
showClass("EnrichedSets")
This function displays an object of class numeric
specifying the significance threshold used to detect DEGs. It takes as input an object of class DEGs
.
FC.threshold(object)
FC.threshold(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
DEGs
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) FC.threshold(limma.DEGs)
data(tRanslatomeSampleData) FC.threshold(limma.DEGs)
This function displays a character vector of column names (or a numeric vector of columns) belonging to expr.matrix. These columns contain the signal intensity data coming from the samples of the first level of the control condition. It takes as input an object of class TranslatomeDataset
.
getConditionA(object)
getConditionA(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) getConditionA(translatome.analysis)
data(tRanslatomeSampleData) getConditionA(translatome.analysis)
This function displays a character vector of column names (or a numeric vector of columns) belonging to expr.matrix. These columns contain the signal intensity data coming from the samples of the first level of the treatment condition. It takes as input an object of class TranslatomeDataset
.
getConditionB(object)
getConditionB(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) getConditionB(translatome.analysis)
data(tRanslatomeSampleData) getConditionB(translatome.analysis)
This function displays a character vector of column names (or a numeric vector of columns) belonging to expr.matrix. These columns contain the signal intensity data coming from the samples of the second level of the control condition. It takes as input an object of class TranslatomeDataset
.
getConditionC(object)
getConditionC(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) getConditionC(translatome.analysis)
data(tRanslatomeSampleData) getConditionC(translatome.analysis)
This function displays a character vector of column names (or a numeric vector of columns) belonging to expr.matrix. These columns contain the signal intensity data coming from the samples of the second level of the treatment condition. It takes as input an object of class TranslatomeDataset
.
getConditionD(object)
getConditionD(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) getConditionD(translatome.analysis)
data(tRanslatomeSampleData) getConditionD(translatome.analysis)
This function displays an object of class character
specifying the names given to the two conditions. By default, the vector is set to c("control","treated")
, but the user can specify other names. It takes as input an object of class TranslatomeDataset
.
getConditionLabels(object)
getConditionLabels(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) getConditionLabels(translatome.analysis)
data(tRanslatomeSampleData) getConditionLabels(translatome.analysis)
This function displays an object of class character
specifying the type of data represented by expr.matrix
. By default it is set to array
, the other accepted value is ngs
. It takes as input an object of class TranslatomeDataset
.
getDataType(object)
getDataType(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) getDataType(translatome.analysis)
data(tRanslatomeSampleData) getDataType(translatome.analysis)
This function displays an object of class DEGs
in which each gene is assigned an expression class: up- or down-regulated at the first level, up- or down-regulated at the second level, up-regulated at both levels, down-regulated at both levels, up-regulated at the first level and down-regulated at the second level and vice versa. It takes as input an object of class TranslatomeDataset
.
getDEGs(object)
getDEGs(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
TranslatomeDataset
computeDEGs
DEGs
data(tRanslatomeSampleData) getDEGs(translatome.analysis)
data(tRanslatomeSampleData) getDEGs(translatome.analysis)
This function displays an object of class character
specifying the method that the user employed in the differential expression analysis. It can have one the following values: limma
, t-test
, TE
, RP
, ANOTA
, DESeq
and none
.By default, this value is set to limma
. It takes as input an object of class DEGs
.
getDEGsMethod(object)
getDEGsMethod(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
DEGs
computeDEGs
TranslatomeDataset
data(tRanslatomeSampleData) getDEGsMethod(limma.DEGs)
data(tRanslatomeSampleData) getDEGsMethod(limma.DEGs)
This function displays a matrix that contains the normalized signal intensity data, each row representing a gene and each column representing a sample. Row names should correspond to gene names, column names should correspond to sample names. It takes as input an object of class TranslatomeDataset
.
getExprMatrix(object)
getExprMatrix(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) getExprMatrix(translatome.analysis)
data(tRanslatomeSampleData) getExprMatrix(translatome.analysis)
This function displays an object of class character
specifying the names given to the two conditions. By default, the vector is set to c("control","treated")
, but the user can specify other names. It takes as input an object of class TranslatomeDataset
.
getLevelLabels(object)
getLevelLabels(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) getLevelLabels(translatome.analysis)
data(tRanslatomeSampleData) getLevelLabels(translatome.analysis)
GOComparison is a function which takes as input an object of class GOsets
, containing the results of a GO enrichment analysis applied to both levels, and returns an object of class GOsims
, containing a variety of comparisons among the enriched GO terms.
GOComparison(object)
GOComparison(object)
object |
an object of class |
An object of class GOsims
Toma Tebaldi, Erik Dassi, Galena Kostoska
Wang et al.(2007) A new method to measure the semantic similarity of go terms Bioinformatics , 23:0 1274-81, May 2007.
data(tRanslatomeSampleData) GOComparison(CCEnrichment)
data(tRanslatomeSampleData) GOComparison(CCEnrichment)
GOEnrichment is a function which, given as input an object of class DEGs
, identifies overrepresented GO terms among differentially expressed genes. The analysis can be applied to all the GO ontologies or restricted to GO terms specifically belonging to one ontology: molecular function, cellular component or biological process. Moreover the function can identify enriched GO terms for separate classes of genes of interest: only up-regulated genes, only down-regulated genes or both of them together. The output of the function is an object of class GOsets
, containing the results of the enrichment analysis.
GOEnrichment(object, ontology="all", classOfDEGs="both", test.method="classic", test.threshold = 0.05, mult.cor=TRUE)
GOEnrichment(object, ontology="all", classOfDEGs="both", test.method="classic", test.threshold = 0.05, mult.cor=TRUE)
object |
an object of class |
ontology |
a character string specifying the GO ontology of interest: |
classOfDEGs |
a character string specifying the class of genes for which we want to detect enriched GO terms: |
test.method |
a character string specifying the statistical method to calculate the enrichment. By default it is set to |
test.threshold |
a numeric value specifying the significance threshold upon which the GO terms are considered significantly over-represented. By default it is se to |
mult.cor |
a boolean variable specifying whether the significance threshold is applied to the multiple test corrected or to the original p-values obtained from the selected enrichment method. By default it is set to |
An object of class GOsets
Toma Tebaldi, Erik Dassi, Galena Kostoska
Ashburner M et al(2000). Gene ontology: tool for the unification of biology. Nat. Genet. May 2000;25(1):25-9.
Alexa A, Rahnenfuhrer J, Lengauer T. Improved scoring of functional groups from gene expression data by decorrelating go graph structure. Bioinformatics 2006, 22(13):1600-7
data(tRanslatomeSampleData) GOEnrichment(limma.DEGs,ontology="CC",classOfDEGs="up", test.method="classic", test.threshold = 0.05,mult.cor = TRUE)
data(tRanslatomeSampleData) GOEnrichment(limma.DEGs,ontology="CC",classOfDEGs="up", test.method="classic", test.threshold = 0.05,mult.cor = TRUE)
GOsets
A class generated from the function GOEnrichment()
containing the overrepresented Gene Ontology terms from the lists of differentially expressed genes coming from the analysis of two different expression levels.
enriched.table
:Object of class data.frame
containing all the GO enrichment analysis. The data frame contains one row for each GO term, while columns are organized as follows:
ontology
, GO ontology of the term, either BP
,CC
or MF
.
level
, level of analysis on which the enrichment is calculated. The names of the two levels are taken from the object DEGs
given as an input to the function GOEnrichment
.
GO.ID
, Gene Ontology accession ID of the term.
term
, Gene Ontology name of the term.
annotated
, number of genes in the human genome associated to the GO term.
significant
, number of genes in the list of DEGs associated to the GO term.
expected
, number of genes in the list of DEGs expected to be associated to the GO term by chance.
expected
, number of genes in the list of DEGs expected to be associated to the GO term by chance.
pv.fisher
, enrichment p-value calculated with the Fisher test. The result is dependent on the method chosen to calculate enrichment(classic
,elim
, weight
,weight01
or parentchild
).
pv.fisher.BH
, the Benjamini-Hochberg corrected enrichment p-value calculated with the Fisher test according to the chosen enrichment method.
label.level.enriched
:Object of class character
specifying the names of the two levels compared in the experiment.
signature(object = "GOsets")
: displays the slot enriched.table
.
signature(object = "GOsets")
: displays the slot label.level.enriched
, slot of class character
specifying the names of the two levels compared in the experiment.
signature(object = "GOsets")
: returns an object of class GOsims
, containing identity and semantic similarity comparisons among the enriched GO terms.
signature(object = "GOsets")
: enables the generation of a heatmap of the top enriched GO terms for the first and second level of analysis.
signature(object = "GOsets")
: enables the generation of a radar plot of the top enriched GO terms for the first and second level of analysis.
signature(object = "GOsets")
: displays all the two slots of the class.
Toma Tebaldi, Erik Dassi, Galena Kostoska
Ashburner M et al(2000). Gene ontology: tool for the unification of biology. Nat. Genet. May 2000;25(1):25-9.
Alexa A, Rahnenfuhrer J, Lengauer T. Improved scoring of functional groups from gene expression data by decorrelating go graph structure. Bioinformatics 2006, 22(13):1600-7.
EnrichedSets
GOComparison
DEGs
showClass("GOsets")
showClass("GOsets")
GOsims
A class generated from the function GOComparison()
containing the result of the differential expression analysis at the two expression levels.
similarity.matrix
:Object of class matrix
containing the semantic similarity comparison between the GO terms enriched at the two levels of analysis. The matrix contains one row for each pairwise comparison between GO terms enriched in the two levels, while columns are organized as follows:
direction
, direction of the comparison: "first level to second level" means that an enriched GO term from the first level is compared to the most similar GO term enriched in the second level, "second level to first level" means that an enriched GO term from the second level is compared to the most similar GO term enriched in the first level. Level names are taken from the object of class GOsets
given as input to the function GOcomparison
.
ontology
, GO ontology of the two terms, either BP
,CC
or MF
.
level
, gene expression levels for which the term is enriched, either "first level only", "second level only" or "both levels". Level names are taken from the object of class GOsets
given as input to the function GOcomparison
.
start.GO.ID
, Gene Ontology accession ID of the first term of the comparison.
start.term
, Gene Ontology name of the first term of the comparison.
end.GO.ID
, Gene Ontology accession ID of the second term of the comparison.
end.term
, Gene Ontology name of the second term of the comparison.
similarity.score
, semantic similarity value between the two campared GO terms.
identity.matrix
:Object of class matrix
containing the identity comparison between the GO terms enriched at the two levels of analysis. The matrix contains one row for each GO term, while columns are organized as follows:
ontology
, GO ontology of the term, either BP
,CC
or MF
.
level
, gene expression levels for which the term is enriched, either "first level only", "second level only" or "both levels". Level names are taken from the object of class GOsets
given as input to the function GOcomparison
.
GO.ID
, Gene Ontology accession ID of the term.
term
, Gene Ontology name of the term.
average.similarity.scores
:Object of class vector
containing the general semantic similarity scores between the GO terms enriched at the two levels of analysis. One similarity score, ranging from 0 to 1, is produced for each GO ontology having at least one enriched term.
signature(object = "GOsims")
: displays the slot identity.matrix
.
signature(object = "GOsims")
: displays the slot similarity.matrix
.
signature(object = "GOsims")
: displays the slot average.similarity.scores
.
signature(object = "GOsims")
: enables the generation of a barplot where, for each GO ontology, the number of GO terms enriched at different levels are displayed.
signature(object = "GOsims")
: enables the generation of a barplot where, for each GO ontology, the semantic similarity value between GO terms enriched at different levels is displayed.
Toma Tebaldi, Erik Dassi, Galena Kostoska
TranslatomeDataset
computeDEGs
GOEnrichment
GOsets
showClass("GOsims")
showClass("GOsims")
Heatmap is a function that plots the top enriched regulatory element or GO terms for the first and second level of analysis in a heatmap. The number of terms to be displayed can be set.
Heatmap(object, outputformat="on screen", n.nodes.1stlevel="5", n.nodes.2ndlevel="5", mult.cor=TRUE, ...)
Heatmap(object, outputformat="on screen", n.nodes.1stlevel="5", n.nodes.2ndlevel="5", mult.cor=TRUE, ...)
object |
an object of class |
outputformat |
a character string specifying if the plot is saved in jpeg ( |
n.nodes.1stlevel |
a numeric value specifying the number of top enriched GO terms, from the first level, that will be represented on the plot. By default the value is set to |
n.nodes.2ndlevel |
a numeric value specifying the number of top enriched GO terms, from the second level, that will be represented on the plot. By default the value is set to |
mult.cor |
a boolean variable specifying whether the displayed significance values are multiple test corrected or the original p-values obtained from the selected enrichment method. By default it is set to |
... |
if the class of object is |
Toma Tebaldi, Erik Dassi, Galena Kostoska
EnrichedSets
RegulatoryEnrichment
GOsets
GOEnrichment
GOsims
data(tRanslatomeSampleData) Heatmap(CCEnrichment, ontology="MF")
data(tRanslatomeSampleData) Heatmap(CCEnrichment, ontology="MF")
This function shows in a histogram the number of genes showing differential expression at both levels, or up/down regulated only at one level.
Histogram(object, plottype ="summary", outputformat="on screen")
Histogram(object, plottype ="summary", outputformat="on screen")
object |
an object of class |
plottype |
a character string specifying whether the histogram should display a summary of DEGs classes ( |
outputformat |
a character string specifying if the plot is saved in jpeg ( |
Toma Tebaldi, Erik Dassi, Galena Kostoska
DEGs
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) Histogram(limma.DEGs,plottype ="summary", outputformat="on screen")
data(tRanslatomeSampleData) Histogram(limma.DEGs,plottype ="summary", outputformat="on screen")
This function displays an object of class character
specifying the names of the two levels compared in the experiment. It takes as input an object of class GOsims
.
identity.matrix(object)
identity.matrix(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
data(tRanslatomeSampleData) identity.matrix(CCComparison)
data(tRanslatomeSampleData) identity.matrix(CCComparison)
This function displays in a barplot, for each GO ontology, the number of GO terms showing enrichment at both levels or only at one level.
IdentityPlot(object, outputformat="on screen")
IdentityPlot(object, outputformat="on screen")
object |
an object of class |
outputformat |
a character string specifying if the plot is saved in jpeg ( |
Toma Tebaldi, Erik Dassi, Galena Kostoska
GOComparison
GOsims
GOsets
GOEnrichment
data(tRanslatomeSampleData) IdentityPlot(CCComparison, outputformat="on screen")
data(tRanslatomeSampleData) IdentityPlot(CCComparison, outputformat="on screen")
This function displays an object of class numeric
specifying the significance threshold used to detect DEGs. It takes as input an object of class DEGs
.
label.condition(object)
label.condition(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
DEGs
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) label.condition(limma.DEGs)
data(tRanslatomeSampleData) label.condition(limma.DEGs)
This function displays an object of class character
specifying the names of the two levels compared in the experiment. It takes as input an object of class DEGs
.
label.level.DEGs(object)
label.level.DEGs(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
DEGs
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) label.level.DEGs(limma.DEGs)
data(tRanslatomeSampleData) label.level.DEGs(limma.DEGs)
This function displays an object of class character
specifying the names of the two levels compared in the experiment. It takes as input an object of class EnrichedSets
or GOsets
.
label.level.enriched(object)
label.level.enriched(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
EnrichedSets
RegulatoryEnrichment
GOsets
GOEnrichment
data(tRanslatomeSampleData) label.level.enriched(CCEnrichment)
data(tRanslatomeSampleData) label.level.enriched(CCEnrichment)
The MA plot displays the average log2 signal of the genes on the x-axis and the log2 fold changes on the y-axis. The upper plot represents a MA plot for the first level of gene expression analysis, whereas the other one refers to the second level. DEGs are color labeled. This function takes as input an object of class DEGs
.
MAplot(object, outputformat="on screen",track="")
MAplot(object, outputformat="on screen",track="")
object |
an object of class |
outputformat |
a character string specifying if the plot is saved in jpeg ( |
track |
a character vector of gene names that will be explicitly highlighted in the scatterplot, if they match any gene contained in the object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
Dudoit, S, Yang, YH, Callow, MJ, Speed, TP. (2002). Statistical methods for identifying differentially expressed genes in replicated cDNA microarray experiments. Stat. Sin. 12:1 111-139
DEGs
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) MAplot(limma.DEGs, outputformat="on screen",track="")
data(tRanslatomeSampleData) MAplot(limma.DEGs, outputformat="on screen",track="")
This function takes as input a normalized data matrix coming from an high-throughput experiment, along with vectors of column names (or numeric vectors of columns) defining the samples for each of the conditions. It takes as an input a character label specifying the data type(array, ngs) and returns an object of the class TranslatomeDataset
, which stores the matrix and the samples definitions and allow to call the computeDEGs
function on it to compute differentially expressed genes in the various conditions.
newTranslatomeDataset(expr.matrix, cond.a, cond.b, cond.c, cond.d, data.type="array", label.level=c("1st level","2nd level"), label.condition=c("control","treated"))
newTranslatomeDataset(expr.matrix, cond.a, cond.b, cond.c, cond.d, data.type="array", label.level=c("1st level","2nd level"), label.condition=c("control","treated"))
expr.matrix |
a matrix that contains the normalized signal intensity data, each row representing a gene and each column representing a sample. Row names should correspond to gene names, column names should correspond to sample names, |
cond.a |
a character vector of column names (or a numeric vector of columns) belonging to expr.matrix. These columns contain the signal intensity data coming from the samples of the first level of the control condition (in our example: total RNA, undifferentiated cells), |
cond.b |
a character vector of column names (or a numeric vector of columns) belonging to expr.matrix. These columns contain the signal intensity data coming from the samples of the first level of the treatment condition(in our example: total RNA, differentiated cells), |
cond.c |
a character vector of column names (or a numeric vector of columns) belonging to expr.matrix. These columns contain the signal intensity data coming from the samples of the second level of the control condition (in our example: polysomal RNA, undifferentiated cells), |
cond.d |
a character vector of column names (or a numeric vector of columns) belonging to expr.matrix. These columns contain the signal intensity data coming from the samples of the second level of the treatment group (in our example: polysomal RNA, differentiated cells), |
data.type |
a character specifying the type of data represented by |
label.level |
a character vector specifying the names given to the two levels. By default the vector is set to |
label.condition |
a character vector specifying the names given to the two conditions. By default, the vector is set to |
Signals contained in expr.matrix should be previously normalized with standard methods (quantile, percentile shift, ... ) when data is coming from microarrays or in the appropriate cases when it is coming from sequencing experiments.
An object of class TranslatomeDataset
Toma Tebaldi, Erik Dassi, Galena Kostoska
TranslatomeDataset
computeDEGs
DEGs
Scatterplot
Histogram
CVplot
MAplot
SDplot
data(tRanslatomeSampleData) translatome.analysis <- newTranslatomeDataset(expressionMatrix, c("tot.undiff.a","tot.undiff.b","tot.undiff.c"), c("tot.diff.a","tot.diff.b","tot.diff.c"), c("pol.undiff.a","pol.undiff.b","pol.undiff.c"), c("pol.diff.a","pol.diff.b","pol.diff.c"), data.type="array", label.level=c("transcriptome","translatome"), label.condition=c("undifferentiated","differentiated"))
data(tRanslatomeSampleData) translatome.analysis <- newTranslatomeDataset(expressionMatrix, c("tot.undiff.a","tot.undiff.b","tot.undiff.c"), c("tot.diff.a","tot.diff.b","tot.diff.c"), c("pol.undiff.a","pol.undiff.b","pol.undiff.c"), c("pol.diff.a","pol.diff.b","pol.diff.c"), data.type="array", label.level=c("transcriptome","translatome"), label.condition=c("undifferentiated","differentiated"))
Radar is a function that plots the top enriched GO terms for the first and second level of analysis in a radar plot. The number of terms to be displayed can be set.
Radar(object ,outputformat="on screen",n.nodes.1stlevel="5", n.nodes.2ndlevel="5",mult.cor=TRUE, ...)
Radar(object ,outputformat="on screen",n.nodes.1stlevel="5", n.nodes.2ndlevel="5",mult.cor=TRUE, ...)
object |
an object of class |
outputformat |
a character string specifying if the plot is saved in jpeg ( |
n.nodes.1stlevel |
a numeric value specifying the number of top enriched GO terms, from the first level, that will be represented on the plot. By default the value is set to |
n.nodes.2ndlevel |
a numeric value specifying the number of top enriched GO terms, from the second level, that will be represented on the plot. By default the value is set to |
mult.cor |
a boolean variable specifying whether the displayed significance values are multiple test corrected or the original p-values obtained from the selected enrichment method. By default it is set to |
... |
if the class of object is |
Toma Tebaldi, Erik Dassi, Galena Kostoska
EnrichedSets
RegulatoryEnrichment
GOsets
GOEnrichment
GOsims
data(tRanslatomeSampleData) Radar(CCEnrichment)
data(tRanslatomeSampleData) Radar(CCEnrichment)
RegulatoryEnrichment is a function which, given as input an object of class DEGs
, identifies overrepresented post-transcriptional regulators (RNA-binding proteins, microRNA, etc) controlling differentially expressed genes. The analysis is by default applied to a dataset of experimentally determined post-transcriptional interactions (i.e. regulator-UTR interaction) extracted from AURA (http://aura.science.unitn.it). However, the user can specify a custom dataset onto which the analysis can be performed (see arguments for details). Moreover, the function can identify enriched regulators for separate classes of genes of interest: only up-regulated genes, only down-regulated genes or both of them together. The method works by exploiting two lists: one containing all genes regulated by each of the post-transcriptional regulators, and the other containing the number of regulated and non-regulated genes for each of these post-transcriptional regulators in the backgroung gene set (usually the whole genome). By means of these two lists it is possible to compute a Fisher enrichment p-value indicating whether a significant group of genes in the DEGs list is likely to be regulated by one or more of these post-transcriptional regulators. The output of the function is an object of class EnrichedSets
, containing the results of the enrichment analysis.
RegulatoryEnrichment(object, classOfDEGs="both", significance.threshold = 0.05, mult.cor=TRUE, regulated.identities=NULL, regulated.counts=NULL)
RegulatoryEnrichment(object, classOfDEGs="both", significance.threshold = 0.05, mult.cor=TRUE, regulated.identities=NULL, regulated.counts=NULL)
object |
an object of class |
classOfDEGs |
a character string specifying the class of genes for which we want to detect enriched regulators: |
significance.threshold |
a numeric value specifying the significance threshold upon which the regulators are considered significantly over-represented. By default it is se to |
mult.cor |
a boolean variable specifying whether the significance threshold is applied to the multiple test corrected or to the original p-values obtained from the selected enrichment method. By default it is set to |
regulated.identities |
a matrix containing two columns (RegulatoryElement, RegulatedGenes) specyifing, for each row, a regulatory element name and the comma-separated list of genes it regulates. The user can use the regulatory.elements.regulated table in the tRanslatomeSampleData dataset as a template. By default this argument is NULL, which implies the dataset obtained from AURA will be used. |
regulated.counts |
a matrix containing three columns (RegulatoryElement, RegulatedGenes, NonRegulatedGenes) specyifing, for each row, a regulatory element name, the number of genes it regulates in the background gene set and the number of genes it does not regulate in the background gene set. The user can use the regulatory.elements.counts table in the tRanslatomeSampleData dataset as a template. By default this argument is NULL, which implies the dataset obtained from AURA will be used. |
An object of class EnrichedSets
Erik Dassi, Toma Tebaldi
Dassi E et al(2012). AURA: Atlas of UTR Regulatory Activity. Bioinformatics. 28(1):142-4.
TranslatomeDataset
computeDEGs
DEGs
data(tRanslatomeSampleData) RegulatoryEnrichment(limma.DEGs, significance.threshold = 0.05)
data(tRanslatomeSampleData) RegulatoryEnrichment(limma.DEGs, significance.threshold = 0.05)
This plot shows each gene as dot uniquely determined by its log2 fold change at the first level (represented on the x-axis) and the fold change at the second level (represented on the y-axis).
Scatterplot(object, outputformat="on screen",track="")
Scatterplot(object, outputformat="on screen",track="")
object |
an object of class |
outputformat |
a character string specifying if the plot is saved in jpeg ( |
track |
a character vector of gene names that will be explicitly highlighted in the scatterplot, if they match any gene contained in the object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
DEGs
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) Scatterplot(limma.DEGs, outputformat="on screen",track="")
data(tRanslatomeSampleData) Scatterplot(limma.DEGs, outputformat="on screen",track="")
The SD plot displays the standard deviations of the genes on the x-axis and the log2 fold changes on the y-axis. The upper plot represents a SD plot for the first level of gene expression analysis, whereas the other one refers to the second level. DEGs are color labeled. This function takes as input an object of class DEGs
.
SDplot(object, outputformat="on screen",track="")
SDplot(object, outputformat="on screen",track="")
object |
an object of class |
outputformat |
a character string specifying if the plot is saved in jpeg ( |
track |
a character vector of gene names that will be explicitly highlighted in the scatterplot, if they match any gene contained in the object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
DEGs
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) SDplot(limma.DEGs, outputformat="on screen",track="")
data(tRanslatomeSampleData) SDplot(limma.DEGs, outputformat="on screen",track="")
This function displays an object of class numeric
specifying the significance threshold used to detect DEGs. It takes as input an object of class DEGs
.
significance.threshold(object)
significance.threshold(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
DEGs
TranslatomeDataset
computeDEGs
data(tRanslatomeSampleData) significance.threshold(limma.DEGs)
data(tRanslatomeSampleData) significance.threshold(limma.DEGs)
This function displays an object of class character
specifying the names of the two levels compared in the experiment. It takes as input an object of class GOsims
.
similarity.matrix(object)
similarity.matrix(object)
object |
an object of class |
Toma Tebaldi, Erik Dassi, Galena Kostoska
data(tRanslatomeSampleData) similarity.matrix(CCComparison)
data(tRanslatomeSampleData) similarity.matrix(CCComparison)
This function displays in a barplot, for each GO ontology, the average semantic similarity value between GO terms showing enrichment at the first or at the second level of analysis.
SimilarityPlot(object, outputformat="on screen")
SimilarityPlot(object, outputformat="on screen")
object |
an object of class |
outputformat |
a character string specifying if the plot is saved in jpeg ( |
Toma Tebaldi, Erik Dassi, Galena Kostoska
data(tRanslatomeSampleData) SimilarityPlot(CCComparison, outputformat="on screen")
data(tRanslatomeSampleData) SimilarityPlot(CCComparison, outputformat="on screen")
TranslatomeDataset
A class generated from the function newTranslatomeDataset()
containing the input matrix, the condition vectors and labels and the result of the differential expression analysis at the two expression levels. This class represents an analysis in its entirety, containing all data from input parameters to output results.
expr.matrix
:Object of class matrix
specifying the normalized signal intensity data, each row representing a gene and each column representing a sample.
cond.a
:Object of class character
specifying a vector of column names belonging to expression matrix. These columns contain the signal intensity data coming from the samples of the first expression level of the control condition.
cond.b
:Object of class character
specifying a vector of column names belonging to expression matrix. These columns contain the signal intensity data coming from the samples of the first expression level of the treatment condition.
cond.c
:Object of class character
specifying a vector of column names belonging to expression matrix. These columns contain the signal intensity data coming from the samples of the second expression level of the control condition.
cond.d
:Object of class character
specifying a vector of column names belonging to expression matrix. These columns contain the signal intensity data coming from the samples of the second expression level of the treatment condition.
data.type
:Object of class character
specifying the type of the data contained in exprMatrix
. The default is "array" and the alternative is "ngs".
label.condition
:Object of class character
specifying the names given to the two conditions. By default, these values are "control" and "treated", but user can specify others.
label.level
:Object of class character
specifying the names given to the two levels. By default levels are named "1st level" and "2nd level", but the user can specify others.
DEGs
:Object of class DEGs
specifying the result of the differential expression analysis at the two expression levels.
signature(object = "TranslatomeDataset")
: displays anObject of class matrix
specifying the normalized signal intensity data, each row representing a gene and each column representing a sample.
signature(object = "TranslatomeDataset")
: displays anObject of class character
specifying a vector of column names belonging to expression matrix. These columns contain the signal intensity data coming from the samples of the first expression level of the control condition.
signature(object = "TranslatomeDataset")
: displays anObject of class character
specifying a vector of column names belonging to expression matrix. These columns contain the signal intensity data coming from the samples of the first expression level of the treatment condition.
signature(object = "TranslatomeDataset")
: displays anObject of class character
specifying a vector of column names belonging to expression matrix. These columns contain the signal intensity data coming from the samples of the second expression level of the control condition.
signature(object = "TranslatomeDataset")
: displays anObject of class character
specifying a vector of column names belonging to expression matrix. These columns contain the signal intensity data coming from the samples of the second expression level of the treatment condition.
signature(object = "TranslatomeDataset")
: displays anObject of class character
specifying the type of the data contained in exprMatrix
. The default is "array" and the alternative is "ngs".
signature(object = "TranslatomeDataset")
: displays anObject of class character
specifying the names given to the two conditions. By default, these values are "control" and "treated", but user can specify others.
signature(object = "TranslatomeDataset")
: displays anObject of class character
specifying the names given to the two levels. By default levels are named "1st level" and "2nd level", but the user can specify others.
signature(object = "TranslatomeDataset")
: displays anObject of class DEGs
specifying the result of the differential expression analysis at the two expression levels.
signature(object = "TranslatomeDataset")
: compute the differentially expressed genes at the two levels by means of the chosen method, returning anObject of class DEGs
.
signature(object = "TranslatomeDataset")
: displays all the slots of the class.
Toma Tebaldi, Erik Dassi, Galena Kostoska
TranslatomeDataset
newTranslatomeDataset
computeDEGs
showClass("TranslatomeDataset")
showClass("TranslatomeDataset")
matrix with data coming from differentiated and undifferentiated human HepaRG cells
data(tRanslatomeSampleData)
data(tRanslatomeSampleData)
tRanslatomeSampleData is a list that has 7 components :
expressionMatrix is a matrix of 12 columns and 1000 rows containing the microarray signals used as input of the function GetDEGs. Columns are organized in biological triplicates as follows: tot.diff.a, tot.diff.b, tot.diff.c contain the signals coming from the transcriptome of the differentiated cell line.
tot.undiff.a, tot.undiff.b, tot.undiff.c contain the signals coming from the transcriptome of the undifferentiated cell line.
pol.diff.a, pol.diff.b, pol.diff.c contain the signals coming from the translatome of the differentiated cell line.
pol.undiff.a, pol.undiff.b, pol.undiff.c contain the signals coming from the translatome of the undifferentiated cell line.
translatome.analysis is an object of class
TranslatomeDataset
generated calling
newTranslatomeDataset()
on expressionMatrix
(see the
examples section for the exactcall).
limma.DEGs is an object of class DEGs
generated
calling getDEGs()
on expressionMatrix
(see the examples
section for the exact call).
CCEnrichment is an object of class GOsets
generated calling GOEnrichment()
on limma.DEGs
(see the
examples section for the exact call).
CCComparison is an object of class GOsims
generated calling GOComparison()
on CCEnrichment
(see the
examples section for the exact call).
regulatory.elements.counts is an object of class data.frame
containing the background numbers of regulated and non-regulated genes
for each post-transcriptional regulatory factor considered by function
RegulatoryEnrichment
.
regulatory.elements.regulated is an object of class data.frame
containing the list of regulated genes for each post-transcriptional regulatory factor considered by function RegulatoryEnrichment
Parent R, Kolippakkam D, Booth G, Beretta L. Mammalian target of rapamycin activation impairs hepatocytic differentiation and targets genes moderating lipid homeostasis and hepatocellular growth. Cancer Res. 2007;67(9):4337-4345
TranslatomeDataset
computeDEGs
DEGs
RegulatoryEnrichment
EnrichedSets
GOEnrichment
GOsets
GOComparison
GOsims
##load the tRanslatome sample data data(tRanslatomeSampleData)
##load the tRanslatome sample data data(tRanslatomeSampleData)