Title: | mirTarRnaSeq |
---|---|
Description: | mirTarRnaSeq R package can be used for interactive mRNA miRNA sequencing statistical analysis. This package utilizes expression or differential expression mRNA and miRNA sequencing results and performs interactive correlation and various GLMs (Regular GLM, Multivariate GLM, and Interaction GLMs ) analysis between mRNA and miRNA expriments. These experiments can be time point experiments, and or condition expriments. |
Authors: | Mercedeh Movassagh [aut, cre] , Sarah Morton [aut], Rafael Irizarry [aut], Jeffrey Bailey [aut], Joseph N Paulson [aut] |
Maintainer: | Mercedeh Movassagh <[email protected]> |
License: | MIT + file LICENSE |
Version: | 1.15.0 |
Built: | 2024-10-30 08:54:37 UTC |
Source: | https://github.com/bioc/mirTarRnaSeq |
glm_...
function.Return canonical model from model type string, function of object. Returns
a model as returned by glm_gaussian()
and others, based on a string,
function or model type object (i.e. "glm_gaussian"
, glm_gaussian
or
glm_gaussian()
).
canonicalModel_(model)
canonicalModel_(model)
model |
string, function or object representing a model type. |
model type object
This is data is the mRNA expression across samples and miRNA expression data which is to be investigated in one file. This data set is used in documentation examples.
This function makes and intersection dataframe for mRNA and miRNA/s of interest to be tested.
combiner(mRNA, miRNA, miRNA_select)
combiner(mRNA, miRNA, miRNA_select)
mRNA |
Matrix or data.frame mRNA/RNA from transforemed diff expression file (genrated using TZtranz) |
miRNA |
Matrix or data frame miRNA from transforemed diff file (genrated using TZtranz) |
miRNA_select |
A vector of character's for miRNAs which the user is interested in investigating if glm is use 1 miRNA should be input. If multivariate several miRNAs should be imported, same goes for interaction determination for miRNAs. Note we do not recommend more than 3-4 miRNAs at a time for the latter cases. |
A dataframe which includes only mRNAs and miRNA intersection for the next estimation geneVari output.
miRNA_select <- c("ebv-mir-bart9-5p") x <- combiner(mRNA, miRNA, miRNA_select)
miRNA_select <- c("ebv-mir-bart9-5p") x <- combiner(mRNA, miRNA, miRNA_select)
This function uses the output of one2OneRnaMiRNA and returns the correlation dataframe
corMirnaRna(mRNA, miRNA, method = "pearson")
corMirnaRna(mRNA, miRNA, method = "pearson")
mRNA |
mRNA file generated from foldchanges (FC) obj of the one2OneRnaMiRNA |
miRNA |
miRNA file generated from foldchanges (FC) obj of the one2OneRnaMiRNA |
method |
Default is "pearson" else use "kendall" or "spearman" |
Correlation data.frame
x <- corMirnaRna(mRNA_fc, miRNA_fc, method = "spearman")
x <- corMirnaRna(mRNA_fc, miRNA_fc, method = "spearman")
This function uses the output of one2OneRnaMiRNA and returns the correlation dataframe.
corMirnaRnaMiranda(mRNA, miRNA, CorVal, getInputSpeciesDF, method = "pearson")
corMirnaRnaMiranda(mRNA, miRNA, CorVal, getInputSpeciesDF, method = "pearson")
mRNA |
mRNA file generated from foldchanges (FC) obj of the one2OneRnaMiRNA. |
miRNA |
miRNA file generated from foldchanges (FC) obj of the one2OneRnaMiRNA |
CorVal |
Correlation cut off.Example: If correlation -0.2 it would only return correlations with smaller than this value correlation for miRNA and mRNA at various time points. |
getInputSpeciesDF |
The dataframe generated from the getInputSpecies function. |
method |
Default is "pearson" else use "kendall" or "spearman". |
Correlation dataframe
x <- corMirnaRnaMiranda(mRNA_fc, miRNA_fc, Cor = -0.9, miRandaM)
x <- corMirnaRnaMiranda(mRNA_fc, miRNA_fc, Cor = -0.9, miRandaM)
This is data is the mRNA FC and miRNA FC correlation data. This data set is used in documentation examples.
Reads internal Miranda file from extdata and returns it as a data.frame
downloadMirandaFile(urlf)
downloadMirandaFile(urlf)
urlf |
URL of the specific chosen file |
data.frame containing downloaded miRanda file
x <- downloadMirandaFile( "https://zenodo.org/record/4615670/files/Mouse_miRanda.txt.gz" )
x <- downloadMirandaFile( "https://zenodo.org/record/4615670/files/Mouse_miRanda.txt.gz" )
This function plots correlations for mRNA and miRNAs regression results (negative correlation for multi and individual interactions and positive and negative for interactions)
drawCorPlot(corMatrix, ...)
drawCorPlot(corMatrix, ...)
corMatrix |
Significant correlation matrix |
... |
parameters form the corrplot package |
miRNA mRNA target correlation plot
x <- drawCorPlot(corMatrix)
x <- drawCorPlot(corMatrix)
This function draws miRNA, mRNA density plots for miRNA and mRNA Interrelation while comparing in addition to overall FC_miRNA and FC_mRNA plots from the finInterResult dataframe function.
drawInterPlots(mrna, mirna, final_results)
drawInterPlots(mrna, mirna, final_results)
mrna |
mRNA results of twoTimePoint function. |
mirna |
miRNA results of twoTimePoint function. |
final_results |
finInterResult miRNA and mRNA interrelation in two timepoints results in a dataframe. |
par plots
x <- drawInterPlots(mRNA_fc2, miRNA_fc2, final_results)
x <- drawInterPlots(mRNA_fc2, miRNA_fc2, final_results)
This function performs FDR correction on the p_values generated by the runModels function list.
fdrSig(RMObj, value = 0.05, method = "fdr")
fdrSig(RMObj, value = 0.05, method = "fdr")
RMObj |
The output of runModels |
value |
The FDR value default is 0.1 |
method |
The p-value adjustment method default is fdr. It could be either of the following "holm", "hochberg", "hommel","bonferroni", "BH", "BY", or "fdr". |
A list of FDR corrected p vlaues, annova, and significance for each gene and the miRNA/s of interest
models <- runModels(Combine, geneVariant, "ebv-mir-bart9-5p") x <- fdrSig(models, value = 0.1, method = "fdr")
models <- runModels(Combine, geneVariant, "ebv-mir-bart9-5p") x <- fdrSig(models, value = 0.1, method = "fdr")
This is data is the mRNA FC and miRNA FC correlation/interaction data results after filteration. This data set is used in documentation examples.
This function uses the output of one2OneRnaMiRNA and returns a sampled from orig file interrelation dataframe depending on user sampling selection.
finInterResult(results)
finInterResult(results)
results |
Results from mirandaIntersectInter |
miRNA mRNA interelation dataframe
x <- finInterResult(results)
x <- finInterResult(results)
This function defines the boudnaries of mRNA vs miRNAs of interest to be analysed by the runModels function
geneVari(Combined, miRNA_select)
geneVari(Combined, miRNA_select)
Combined |
the combined file for mRNA and selected miRNAs output of combiner function |
miRNA_select |
The vector of selected miRNA/s |
A vector of characters with defined mRNA dimensions
x <- geneVari(Combine, "ebv-mir-bart9-5p")
x <- geneVari(Combine, "ebv-mir-bart9-5p")
This is data is the mRNA expression across samples and miRNA expression data which is to be investigated giving directions on which data is miRNA and which is mRNA. This data set is used in documentation examples.
Reads Miranda file for a given speicies and returns it as a data.frame, thresholded by percent identity. Header options are Score (threshold), Energy-Kcal/Mol(energy), Subject-IdentityPercent(targetIden), Query-IdentityPercent (mirnaIden)
getInputSpecies( selection, threshold = 60, energy = NULL, targetIden = NULL, mirnaIden = NULL )
getInputSpecies( selection, threshold = 60, energy = NULL, targetIden = NULL, mirnaIden = NULL )
selection |
Species (species selection are either for mature miRNA species "Human1","Mouse", "C.elegans", "Epstein_Barr", "Epstein_Barr_Human", "Drosophila","Kaposi_Sarcoma", "KSHV_Human", "Cytomegalovirus","CMV_Human") |
threshold |
miRanda score threshold default 60 |
energy |
miRanda folding energy threshold default NULL |
targetIden |
miRanda target identity score default NULL |
mirnaIden |
miRanda mirna identity score default NULL |
data.frame with Miranda data.
x <- getInputSpecies("Epstein_Barr", threshold = 60) # Default is threshold 60
x <- getInputSpecies("Epstein_Barr", threshold = 60) # Default is threshold 60
Implements standardized functions to fit the glm with Gaussian family and to obtain coefficients, pvalues, etc.
glm_gaussian()
glm_gaussian()
structure containing functions fit
, coefficients
,
aic
, data
, pterm
, pmodel
, and a
character string "glm_gaussian" in model
.
x <- glm_gaussian()
x <- glm_gaussian()
Runs models 'glm_gaussian', 'glm_nb', 'glm_poisson', 'glm_zeroinfl(poisson)', 'glm_zeroinfl(negbin)' and returns mode with lowest AIC.
glm_multi( models = c(glm_gaussian, glm_nb, glm_poisson, glm_zeroinfl_poisson, glm_zeroinfl_negbin) )
glm_multi( models = c(glm_gaussian, glm_nb, glm_poisson, glm_zeroinfl_poisson, glm_zeroinfl_negbin) )
models |
Model type, one or more of glm_gaussian, glm_nb, glm_poisson, glm_zeroinfl_poisson or glm_zeroinfl_negbin |
structure containing functions fit
, coefficients
,
aic
, data
, pterm
, pmodel
, and a
character string "glm_multi" in model
.
x <- glm_multi()
x <- glm_multi()
Implements standardized functions to fit the negative binomial GLM and to obtain coefficients, pvalues, etc.
glm_nb()
glm_nb()
structure containing functions fit
, coefficients
,
aic
, data
, pterm
, pmodel
, and a
character string "glm_nb" in model
.
x <- glm_nb()
x <- glm_nb()
Implements standardaized functions to fit the glm with Poisson family and to obtain coefficients, pvalues, etc.
glm_poisson()
glm_poisson()
structure containing functions fit
, coefficients
,
aic
, data
, pterm
, pmodel
, and a
character string "glm_poisson" in model
.
x <- glm_poisson()
x <- glm_poisson()
Implements standardaized functions to fit the zero inflated model with Poisson or Negative Binomial distribution, and to obtain coefficients, pvalues, etc.
glm_zeroinfl(dist = "poisson")
glm_zeroinfl(dist = "poisson")
dist |
either 'poisson' or 'negbin' |
structure containing functions fit
, coefficients
,
aic
, data
, pterm
, pmodel
, and a
character string "glm_zeroinfl" in model
.
x <- glm_zeroinfl("negbin")
x <- glm_zeroinfl("negbin")
alias for glm_zeroinfl("negbin")
glm_zeroinfl_negbin(...)
glm_zeroinfl_negbin(...)
... |
passed to |
structure containing functions fit
, coefficients
,
aic
, data
, pterm
, pmodel
, and a
character string "glm_zeroinfl" in model
.
x <- glm_zeroinfl_negbin()
x <- glm_zeroinfl_negbin()
alias for glm_zeroinfl("poisson")
glm_zeroinfl_poisson(...)
glm_zeroinfl_poisson(...)
... |
passed to |
structure containing functions fit
, coefficients
,
aic
, data
, pterm
, pmodel
, and a
character string "glm_zeroinfl" in model
.
x <- glm_zeroinfl_poisson()
x <- glm_zeroinfl_poisson()
Reads internal Miranda file from extdata and returns it as a data.frame
importMirandaFile(fn)
importMirandaFile(fn)
fn |
filename |
data.frame containing Miranda data
x <- importMirandaFile("Mouse_miRanda.txt")
x <- importMirandaFile("Mouse_miRanda.txt")
This is data is the mRNA FC and miRNA FC correlation/interaction original data. This data set is used in documentation examples.
This function make right hand side of formula for model variables: vector of indep. variables (i.e. miRNAs) mode: 'multi' for simple, 'inter' for model with interactions returns a string in the form "~ a + b", or "~ a + b + a * b"
makeFormulaRightSide(variables, mode = "multi")
makeFormulaRightSide(variables, mode = "multi")
variables |
The vector created by miRNA_select |
mode |
One of "multi", "inter" or NULL |
data.frame containing Miranda data
x <- makeFormulaRightSide(variables, mode = "multi")
x <- makeFormulaRightSide(variables, mode = "multi")
This function generates a dataframe consisting of mRNA or miRNAs present in miRanda generated file using the miRTarRNASeq:::getInputSpecies() function
miRanComp(miRNA, miRanda)
miRanComp(miRNA, miRanda)
miRNA |
Matrix or data.frame miRNA/RNA file or transformed diff expression file (generated using TZtranz) |
miRanda |
A dataframe of miRanda file with miRNA$V1 and miRNA targets miRNA$V2 |
An miRNA expression dataframe which includes only Genes/Targets present in miRanda file
x <- miRanComp(miRNA, miRanda)
x <- miRanComp(miRNA, miRanda)
This is data is the results file from EBV miRanda getInputSpecies function. This data set is used in documentation examples.
Transforms miRanda data into adjacency matrix, with 1 indicating presence of a relationship between a mRNA and miRNA, and 0 otherwise. miRanda input is filtered by miRNA and mRNA present in 'mirna_exp' and 'diff_expr' row names, respectively.
miranda_sponge_predict(mirna_exp, diff_exp, miranda_data)
miranda_sponge_predict(mirna_exp, diff_exp, miranda_data)
mirna_exp |
miRna expression data.frame with miRNA for rows and samples for columns |
diff_exp |
mRNA expression data.frame with mRNA for rows and samples for columns |
miranda_data |
miRanda data.frame with the first two columns having miRNA and mRNA names |
matrix adjacency matrix with column names miRNA and row names mRNA
Compares and looks for intersection if significant output results with miRanda Results from getInputSpeciesDF and outputs a final filtered output for only those pairs of miRNA and mRNA which have actually been predicted to be targets in miRanda file function
miRandaIntersect(sig_corrs, corrS, mRNA, miRNA, getInputSpeciesDF)
miRandaIntersect(sig_corrs, corrS, mRNA, miRNA, getInputSpeciesDF)
sig_corrs |
correlation matrix, produced by threshSig. |
corrS |
vector of correlations/differences, from the sampCorRnaMirna function. |
mRNA |
mRNA FC matrix. |
miRNA |
miRNA FC matrix. |
getInputSpeciesDF |
miranda data, produced by getInputSpecies. |
An object containing data.frames of significant mRNA, miRNA and correlation matrix filtered by miRanda input.
x <- miRandaIntersect(sig_InterR, outs2, mRNA_fc, miRNA_fc, miRandaM)
x <- miRandaIntersect(sig_InterR, outs2, mRNA_fc, miRNA_fc, miRandaM)
Compares and looks for intersection if significant output results with miRanda Results from getInputSpeciesDF and outputs a final filterd ourput for only those pairs of miRNA and mRNA which have actually been predicted to be targets in miRanda file function
mirandaIntersectInter(sig_corrs, corrS, mRNA, miRNA, getInputSpeciesDF)
mirandaIntersectInter(sig_corrs, corrS, mRNA, miRNA, getInputSpeciesDF)
sig_corrs |
correlation matrix, produced by threshSig |
corrS |
vector of Differences/Correlations, from the sampCorRnaMirna function. |
mRNA |
mRNA FC matrix. |
miRNA |
miRNA FC matrix. |
getInputSpeciesDF |
miranda data, produced by getInputSpecies. |
An object containing data.frames of significant mRNA, miRNA and correlation matrix filtered by miranda input.
x <- mirandaIntersectInter(sig_InterR, outs2, mRNA_fc2, miRNA_fc2, miRandaM)
x <- mirandaIntersectInter(sig_InterR, outs2, mRNA_fc2, miRNA_fc2, miRandaM)
This is data is the results file from mouse miRanda getInputSpecies function. This data set is used in documentation examples.
This is data is the miRNA expression file. This data set is used in documentation examples.
This is data is the combined miRNA FC for all time points. This data set is used in documentation examples.
This data is the miRNA fold change data set for difference or interrelation section. This data set is used in documentation examples.
This is data is the miRNA0_2 FC for 0-2 time point. This data set is used in documentation examples.
This is data is the miRNA0_5 FC for 0-5 time point. This data set is used in documentation examples.
This is data is the miRNA2_5 FC for 2-5 time point. This data set is used in documentation examples.
This function draws density plots for miRNA and mRNA correlation while comparing real data vs sampled data. It mainly illustrates the where the lower relationships lie.
mirRnaDensityCor(corr0, corrS, pvalue = 0.05)
mirRnaDensityCor(corr0, corrS, pvalue = 0.05)
corr0 |
data.frame results of corMirnaRna function. |
corrS |
data.frame results from the sampCorRnaMirna function. |
pvalue |
The p value threshold to be used on the data density plot default is 0.05. |
Density plot
x <- mirRnaDensityCor(corr_0, outs, pvalue = 0.05)
x <- mirRnaDensityCor(corr_0, outs, pvalue = 0.05)
This function draws density plots for miRNA and mRNA Interrelation while comparing real data vs sampled data. It mainly illustrates the where the lower relationships lie.
mirRnaDensityInter(Inter0, OUTS, pvalue = 0.05)
mirRnaDensityInter(Inter0, OUTS, pvalue = 0.05)
Inter0 |
data.frame results of twoTimePoint function. |
OUTS |
data.frame results from the twoTimePointSamp function. |
pvalue |
The p value threshold to be used on the data density plot default is 0.05. |
Density plot
x <- mirRnaDensityInter(Inter0, OUTS, pvalue = 0.05)
x <- mirRnaDensityInter(Inter0, OUTS, pvalue = 0.05)
This function draws pheatmaps for miRNA and mRNA correlation while using default and pheatmap for all other parameters
mirRnaHeatmap( finalF, ..., upper_bound = 0, main = "Default mRNA miRNA heatmap", color = c(viridis::inferno(50), "grey90"), fontsize = 7 )
mirRnaHeatmap( finalF, ..., upper_bound = 0, main = "Default mRNA miRNA heatmap", color = c(viridis::inferno(50), "grey90"), fontsize = 7 )
finalF |
data.frame results of corMirnaRnaMiranda or corMirnaRna function |
... |
arguments passed onto pheatmap |
upper_bound |
is the upper_bound of the correlation pheatmap scale default is zero user can set to values based on output of correlation result (value) |
main |
is the title of the pheatmap |
color |
default inferno(50) from the library viridis R base, R colorbrewer and viridis compatible |
fontsize |
default is 7 user adjustable |
pheatmap Obj
x <- mirRnaHeatmap(corr_0)
x <- mirRnaHeatmap(corr_0)
This function draws heatmaps (pheatmaps) for miRNA and mRNA correlation while using default and heatmap for all other parameters
mirRnaHeatmapDiff( finalF, ..., upper_bound = 0, main = "Default mRNA miRNA heatmap", color = c("grey90", viridis::inferno(50)), fontsize = 7 )
mirRnaHeatmapDiff( finalF, ..., upper_bound = 0, main = "Default mRNA miRNA heatmap", color = c("grey90", viridis::inferno(50)), fontsize = 7 )
finalF |
data.frame results of corMirnaRnaMiranda or corMirnaRna function |
... |
arguments passed onto pheatmap |
upper_bound |
is the upper_bound of the correlation pheatmap scale default is zero user can set to values based on output of correlation result (value) |
main |
is the title of the pheatmap |
color |
default inferno(50) from the library viridis R base, R colorbrewer and viridis compatible |
fontsize |
default is 7 user adjustable |
pheatmap Obj
x <- mirRnaHeatmapDiff(results$corrs, upper_bound = -0.1, color = rainbow(50), fontsize = 10)
x <- mirRnaHeatmapDiff(results$corrs, upper_bound = -0.1, color = rainbow(50), fontsize = 10)
Obtain model AIC
modelAIC(x)
modelAIC(x)
x |
fitted model |
AIC for model
modelAIC(some_model)
modelAIC(some_model)
Obtain coefficients
modelCoefficients(x)
modelCoefficients(x)
x |
fitted model |
fitted model coefficients
modelCoefficients(some_model)
modelCoefficients(some_model)
Obtain model input data
modelData(x)
modelData(x)
x |
fitted model |
Input data for the fitted model
x <- modelData(some_model)
x <- modelData(some_model)
Obtain model name
modelModelName(x)
modelModelName(x)
x |
fitted model |
model name
modelModelName(some_model)
modelModelName(some_model)
Obtain model p-value
modelModelPvalue(x)
modelModelPvalue(x)
x |
fitted model |
Pvalue for the model
modelModelPvalue(some_model)
modelModelPvalue(some_model)
This function can be used to filter a list of models (such as returned by runModelsZInf()
)
based on a logical expression.
modelsFilter(models, expr, quiet = FALSE)
modelsFilter(models, expr, quiet = FALSE)
models |
list of models and related elemenets, such as returned by |
expr |
expresion that yields a logical vector (evaluated in the environmnet of |
quiet |
suppress warnings |
models
but with all elements filtered by logical expression expr
. Elements
for which filter could not be applied (e.g. length mismatch between element and condition)
are set to NA
.
x <- modelsFilter(models, pvalues < 0.05) x <- modelsFilter(models, is_significant) x <- modelsFilter(models, is_significant == FALSE)
x <- modelsFilter(models, pvalues < 0.05) x <- modelsFilter(models, is_significant) x <- modelsFilter(models, is_significant == FALSE)
Obtain p-values for terms in model formula
modelTermPvalues(x)
modelTermPvalues(x)
x |
fitted model |
Pvalue for the terms in the fitted model
modelTermPvalues(some_model)
modelTermPvalues(some_model)
This is data is the mRNA expression file. This data set is used in documentation examples.
This is data is the combined mRNA FC for all time points. This data set is used in documentation examples.
This data is the mRNA fold change data set for difference or interrelation section. This data set is used in documentation examples.
This is data is the mRNA0_2 FC for 0-2 time point. This data set is used in documentation examples.
This is data is the mRNA0_5 FC for 0-5 time point. This data set is used in documentation examples.
This is data is the mRNA2_5 FC for 2-5 time point. This data set is used in documentation examples.
Sparse Partial Correlations On mRNA/miRNA Expression We make mirTarRnaSeq compatible to SPONGE package in order to estimate sparse matrix correlation (using elstic net) for prediction potential miRNA-mRNA interaction. Note this function/method is suggested for miRNA/mRNA interactions in many samples with a notable variance of mRNA/miRNA expression. This model also only reports negative sparse partial correlation predictions.
one2manySponge(mirna_exp, diff_exp, miranda_sponge_predict, non_null = TRUE)
one2manySponge(mirna_exp, diff_exp, miranda_sponge_predict, non_null = TRUE)
mirna_exp |
miRna expression data.frame with miRNA for rows and samples for columns |
diff_exp |
mRNA expression data.frame with mRNA for rows and samples for columns |
miranda_sponge_predict |
miRanda sponge compatible matrix produced by miranda_sponge_predict function |
non_null |
The default for this parameter is TRUE, hence it returns only non-null estimated if FALSE it would return all NULL and TRUE estimates. |
matrix adjacency matrix with column names miRNA and row names mRNA
This function inputs accept a list of dataframes and returns an obj with two dataframes called FC and p-value. FC with rownames == genes and columns are FC1, 2, 3, ... (with fold-changes) - P-value with rownames == genes and columns are P1, 2, 3, ... (with p-values) both data.frames have the same order dimensions.
one2OneRnaMiRNA( files, gene_colname = "Gene", fc_colname = "FC", pval_colname = "pvalue", pthreshold = NULL )
one2OneRnaMiRNA( files, gene_colname = "Gene", fc_colname = "FC", pval_colname = "pvalue", pthreshold = NULL )
files |
a list of dataframes either miRNAs or mRNAs from various time points. |
gene_colname |
Default is a vector character of length 1 "Gene" user can alter if they choose This column contains the gene names. |
fc_colname |
Default "FC" is coloumn name for fold changes user can alter if they choose. |
pval_colname |
Default is "pvalue" column name for p-values (in input). |
pthreshold |
P-value threshold. |
Correlation dataframe
x <- one2OneRnaMiRNA(files)
x <- one2OneRnaMiRNA(files)
This is data is the output file resulted from time point/conditions background correlation model. This data set is used in documentation examples.
This is data is the output file resulted from time point/conditions background difference/interelation model. This data set is used in documentation examples.
Plot 2D description
plotFit(model)
plotFit(model)
model |
linear model |
does not return value
plotFit(lm(x ~ y, data = data.frame(x = runif(10), y = runif(10))))
plotFit(lm(x ~ y, data = data.frame(x = runif(10), y = runif(10))))
Plot residuals description
plotResiduals(model)
plotResiduals(model)
model |
linear model |
does not return value
plotResiduals(lm(x ~ y, data = data.frame(x = runif(10), y = runif(10))))
plotResiduals(lm(x ~ y, data = data.frame(x = runif(10), y = runif(10))))
Plot terms description
plotTerms(model)
plotTerms(model)
model |
linear model |
does not return value
plotTerms(lm(x ~ y, data = data.frame(x = runif(10), y = runif(10))))
plotTerms(lm(x ~ y, data = data.frame(x = runif(10), y = runif(10))))
This is data is the output file resulted from time point or conditions or correlation or interrelation model. This data set is used in documentation examples.
This function runs the "runModel" function for all miRNAs and mRNA combinations of two and returns a list with significant genes and FDR models
runAllMirnaModels( mirnas, DiffExpmRNA, DiffExpmiRNA, miranda_data, prob = 0.75, fdr_cutoff = 0.1, method = "fdr", cutoff = 0.05, all_coeff = FALSE, mode = NULL, family = glm_poisson(), scale = 1 )
runAllMirnaModels( mirnas, DiffExpmRNA, DiffExpmiRNA, miranda_data, prob = 0.75, fdr_cutoff = 0.1, method = "fdr", cutoff = 0.05, all_coeff = FALSE, mode = NULL, family = glm_poisson(), scale = 1 )
mirnas |
vector of unique miRNAs under investigation. |
DiffExpmRNA |
deferentially/expressed mRNAs expression file. |
DiffExpmiRNA |
deferentially/expressed miRNAs expression file. |
miranda_data |
getInputSpecies output file ( use low filters). |
prob |
user defined ratio for miRanda distribution for miRanda score selection default is 0.75. |
fdr_cutoff |
cutoff for FDR selection default is 0.1. |
method |
finInterResult miRNA and mRNA interrelation in two time points results in a dataframe. |
cutoff |
P-value cutoff of the model. |
all_coeff |
if true only models with all negative coefficients will be selected if false at least one negative coefficient should be in the model; default is TRUE. |
mode |
model mode, default is Null, can be changed to "multi" and "inter". |
family |
Default is glm_poisson(), for zero inflated negative binomial NB option use glm_zeroinfl(dist="negbin"). |
scale |
if normalized data (FPKM,RPKM,TPM,CPM), scale to 10 etc., however the higher you go on #scale the less accuracy your p-value estimate will be. |
List of run models
mirnas <- c("ebv-mir-bart9-5p", "ebv-mir-bart6-3p") x <- runAllMirnaModels(mirnas, mRNA, miRNA, miRanda, prob = 0.90, fdr_cutoff = 0.1, method = "fdr", all_coeff = TRUE, mode = "multi", family = glm_poisson(), scale = 100 )
mirnas <- c("ebv-mir-bart9-5p", "ebv-mir-bart6-3p") x <- runAllMirnaModels(mirnas, mRNA, miRNA, miRanda, prob = 0.90, fdr_cutoff = 0.1, method = "fdr", all_coeff = TRUE, mode = "multi", family = glm_poisson(), scale = 100 )
Run a model of a specific kind
runModel(x, data, ..., model = glm_gaussian())
runModel(x, data, ..., model = glm_gaussian())
x |
model formula |
data |
data.frame to run the model on |
... |
passed on to |
model |
model type |
fitted model
This function defines the boundaries of mRNA vs miRNAs of interest to be analysed by the runModels function
runModels( combination, select_mRNA, select_miRNA, mode = NULL, family = glm_poisson(), scale = 1, cutoff = 0.05, all_coeff = NULL )
runModels( combination, select_mRNA, select_miRNA, mode = NULL, family = glm_poisson(), scale = 1, cutoff = 0.05, all_coeff = NULL )
combination |
the combined file for mRNA and selected miRNAs output of combiner function |
select_mRNA |
the output of gene_variant function. |
select_miRNA |
The vector of miRNA/s to be investigated. |
mode |
the mode of analysis if more than one miRNA is being investigated multivariate "multi" or co-variate/interaction analysis "inter" is being used |
family |
gaussian or poisson |
scale |
factor to scale input data (for genes) by, prior to rounding and model
fitting. ( |
cutoff |
p-value cut off to call significance |
all_coeff |
if true only models with all negative coefficients will be selected if false at least one |
A list of p-vlaues, annova, and significance for each gene and the miRNA/s of interest
x <- runModels(Combine, geneVariant, "ebv-mir-bart9-5p")
x <- runModels(Combine, geneVariant, "ebv-mir-bart9-5p")
This function uses the output of one2OneRnaMiRNA and returns a sampled from original file correlation dataframe depending on user sampling selection.
sampCorRnaMirna( mRNA, miRNA, method = "pearson", Shrounds = 100, Srounds = 1000 )
sampCorRnaMirna( mRNA, miRNA, method = "pearson", Shrounds = 100, Srounds = 1000 )
mRNA |
mRNA file generated from fold changes (FC) obj of the one2OneRnaMiRNA. |
miRNA |
miRNA file generated from fold changes (FC) obj of the one2OneRnaMiRNA. |
method |
Default is "pearson" else use "kendall" or "spearman". |
Shrounds |
number of shuffling over the FC data, default is 100. |
Srounds |
number of sampling from the shuffled data, default is 1000. |
Correlation data frame
x <- sampCorRnaMirna(mRNA_fc, miRNA_fc, method = "pearson", Shrounds = 10, Srounds = 10)
x <- sampCorRnaMirna(mRNA_fc, miRNA_fc, method = "pearson", Shrounds = 10, Srounds = 10)
This is data is the output file resulted from time point or conditions experiment for correlation model after filtering and threshold modification. This data set is used in documentation examples.
This is data is the output file resulted from time point or conditions experiment for interrelation model after filtering and threshold modification. This data set is used in documentation examples.
This is data is the results file from regression analysis and its estimates. This data set is used in documentation examples.
This function uses the sampCorRnaMirna shuffled output to determine an appropriate threshold for significant mRNA and miRNA relationship of the dataset and shows all those with significant relationships.
threshSig(corr0, corrS, pvalue = 0.05)
threshSig(corr0, corrS, pvalue = 0.05)
corr0 |
data.frame results of corMirnaRna function. |
corrS |
vector of correlations, from the sampCorRnaMirna function. |
pvalue |
The p value threshold to be used on the sampled data. |
A dataframe of Significant mRNA and miRNA
x <- mirRnaHeatmap(outs, corr_0)
x <- mirRnaHeatmap(outs, corr_0)
This function uses the sampCorRnaMirna shuffled output to determine an appropriate thershold for significant mRNA and miRNA relationship of the dataset and shows all those with significant relationships.
threshSigInter(corr0, corrS, pvalue = 0.05)
threshSigInter(corr0, corrS, pvalue = 0.05)
corr0 |
data.frame results of corMirnaRna function. |
corrS |
vector of correlations, from the sampCorRnaMirna function. |
pvalue |
The p value threshold to be used on the sampled data. |
A dataframe of Significant mRNA and miRNA
x <- threshSigInter(corr_0, outs, pvalue = 0.05)
x <- threshSigInter(corr_0, outs, pvalue = 0.05)
This function uses the output of one2OneRnaMiRNA and returns a sampled from original file interrelation dataframe depending on user sampling selection.
twoTimePoint(mRNA, miRNA)
twoTimePoint(mRNA, miRNA)
mRNA |
mRNA file generated from fold changes (FC) obj of the one2OneRnaMiRNA. |
miRNA |
miRNA file generated from fold changes (FC) obj of the one2OneRnaMiRNA. |
miRNA mRNA interrelation dataframe
x <- twoTimePoint(mRNA_fc2, miRNA_fc2)
x <- twoTimePoint(mRNA_fc2, miRNA_fc2)
This function uses the output of one2OneRnaMiRNA and returns a sampled from orig file interrelation dataframe depending on user sampling selection.
twoTimePointSamp(mRNA, miRNA, Shrounds = 100, Srounds = 1000)
twoTimePointSamp(mRNA, miRNA, Shrounds = 100, Srounds = 1000)
mRNA |
mRNA file generated from fold changes (FC) obj of the one2OneRnaMiRNA. |
miRNA |
miRNA file generated from fold changes (FC) obj of the one2OneRnaMiRNA. |
Shrounds |
number of shuffling over the FC data, default is 100. |
Srounds |
number of sampling from the shuffled data, default is 1000. |
miRNA mRNA interrelation dataframe
x <- twoTimePointSamp(mRNA, miRNA, Shrounds = 10, Srounds = 10)
x <- twoTimePointSamp(mRNA, miRNA, Shrounds = 10, Srounds = 10)
Transposes and z-score transforms a matrix or data.frame.
tzTrans(x)
tzTrans(x)
x |
matrix of miRNA or mRNA or the data frame to be transformed |
transposed and transformed version of x as a matrix.
x <- tzTrans(miRNA)
x <- tzTrans(miRNA)