Package Glimma. April 14, 2017

Size: px
Start display at page:

Download "Package Glimma. April 14, 2017"

Transcription

1 Type Package Title Interactive HTML graphics Version Date Author Shian Su, Matt Ritchie, Charity Law Maintainer Shian Su Package Glimma April 14, 2017 This package generates interactive visualisations for analysis of RNA-sequencing data using output from limma, edger or DESeq2 packages in an HTML page. The interactions are built on top of the popular static representations of analysis results in order to provide additional information. biocviews DifferentialEpression, ReportWriting, RNASeq, Visualization Depends R (>= 3.3.0) Imports DESeq2, edger, grdevices, methods, stats, utils Suggests BiocStyle, limma License GPL-3 file LICENSE URL BugReports RoygenNote NeedsCompilation no LazyData true R topics documented: as.hecol CharToHeCol glautoinput glbar glbar.default glimma gllink glmdplot glmdplot.default glmdplot.deseqdataset glmdplot.deseqresults

2 2 as.hecol glmdplot.dgeeact glmdplot.dgelrt glmdplot.marraylm glmdsplot glmdsplot.default glmdsplot.dgelist glscatter glscatter.default gltable gltablink glxyplot hascolumns lymphomarnaseq makejson.chart makejson.data.frame NumToHeCol Inde 27 as.hecol Numeric to he colour converter Functions to convert numbers into corresponding he codes for colours as.hecol() the colour value(s) to be converted to he values. he codes for colours Eamples as.hecol(c(1, 2, 3)) as.hecol(c("red", "black", "green"))

3 CharToHeCol 3 CharToHeCol String to he colour converter Function to convert colour strings into he codes CharToHeCol() the string colour value(s) to be converted to he values. he codes for colours glautoinput Glimma Autocomplete Input Create an autocompleted input field. glautoinput(target, action, idval = "none", flag = "none") target action idval flag the inde of the plot which receives the event and performs an action. the action to be performed at target plot using input information. the column from which the autocomplete list will be populated. indicates special flags for custom features. a input object containing the input field information.

4 4 glbar.default glbar Glimma MD Plot Create an interactive bar plot object. glbar(,...) the data.frame containing data to plot.... additional arguments depending on input object type. A chart object containing the information to create an interactive bar plot. Shian Su See Also glbar.default Eamples data(mtcars) counts <- table(mtcars$gear) data <- data.frame(ngears=as.numeric(names(counts)), Count=as.numeric(counts)) plot1 <- glbar(data, "Count", "ngears", ylab="number of Gears") glimma(plot1, layout=c(1,1), launch=true) glbar.default Glimma MD Plot Default method for interactive bar plot. ## Default S3 method: glbar(, yval, names.arg = rownames(), ndigits = NULL, signif = 6, lab = NULL, ylab = yval, main = NULL, height = 400, width = 500, colval = NULL, annot = yval, flag = NULL, info = NULL,...)

5 glimma 5 the data.frame containing data to plot. yval the column name for the -ais values. names.arg the column name for the label on each bar. ndigits the number of digits after the decimal to round to in the tooltip (overrides signif). signif the number of significant figures to display in the tooltip. lab the label on the -ais. ylab the label on the y-ais. main the title for the plot. height the height of the plot (in piels). width the width of the plot (in piels). colval the colours for each data point. annot the columns to display in the tooltip. flag the special flag to indicate special plot. info additional information for plotting.... additional arguments. A chart object containing the information to create an interactive bar plot. Shian Su Eamples data(mtcars) counts <- table(mtcars$gear) data <- data.frame(ngears=as.numeric(names(counts)), Count=as.numeric(counts)) plot1 <- glbar(data, "Count", "ngears", ylab="number of Gears") glimma(plot1, layout=c(1,1), launch=true) glimma Glimma plot manager Core glimma plot manager. Generates environment for glimma plots. glimma(..., layout = c(1, 1), path = getwd(), folder = "glimma-plots", html = "inde", overwrite = TRUE, launch = TRUE)

6 6 gllink... the jschart or jslink objects for processing. layout path folder html overwrite launch the numeric vector representing the number of rows and columns in plot window. the path in which the folder will be created. the name of the fold to save html file to. the name of the html file to save plots to. the option to overwrite eisting folder if it already eists. TRUE to launch plot after call. Generates interactive plots based on filling layout row by row from left to right. Eamples data(iris) plot1 <- glscatter(iris, val="sepal.length", yval="sepal.width", colval="species") glimma(plot1, c(1,1)) gllink Plot linkages Helper function for writing the link properties in interactive Glimma plots gllink(from, to, src = "none", dest = "none", flag = "none", both = FALSE, info = "none") from to src dest flag both info the inde of the plot from which the event is dispatched. the inde of the plot which receives the event and performs an action. the action that is performed in the "from" plot. the action that is performed in the "to" plot. indicates special links for particular chart types. creates symmetric links whereby the "dest" action in "to" also triggers the "src" action in "from". additional info for creating the link. a link object containing the plot linking information.

7 glmdplot 7 Eamples data(iris) data <- data.frame(name=paste("flower", 1:nrow(iris), sep="-"), iris) plot1 <- glscatter(data, val="sepal.length", yval="sepal.width", colval="species") plot2 <- glscatter(data, val="species", yval="petal.length", colval="species") link1 <- gllink(1, 2, src="hover", dest="hover", both=true) glimma(plot1, plot2, link1, layout=c(1,2)) glmdplot Glimma MD Plot Draw an interactive MD plot glmdplot(,...) the DE object to plot.... additional arguments affecting the plots produced. See specific methods for detailed arguments. Draws a two-panel interactive MD plot in an html page. The left plot shows the log-fold-change vs average epression. The right plot shows the epression levels of a particular gene of each sample. Hovering over points on left plot will plot epression level for corresponding gene, clicking on points will fi the epression plot to gene. Clicking on rows on the table has the same effect as clicking on the corresponding gene in the plot. See Also Shian Su glmdplot.default, glmdplot.dgelrt, glmdplot.dgeeact, glmdplot.marraylm, glmdplot.deseqdataset Eamples library(limma) library(edger) data(lymphomarnaseq) <- lymphomarnaseq sel <- rowsums(cpm($counts)>0.5)>=3

8 8 glmdplot.default <- [sel,] genotype <- relevel($samples$group, "Smchd1-null") <- calcnormfactors(, method="tmm") des <- model.matri(~genotype) ## Apply voom with sample quality weights and fit linear model v <- voomwithqualityweights(, design=des, normalization="none", plot=false) vfit <- lmfit(v,des) ## Apply treat relative to a fold-change of 1.5 vtfit <- treat(vfit,lfc=log2(1.5)) vfit <- ebayes(vfit) results <- decidetests(vfit,p.value=0.01) glmdplot(vfit, counts=$counts, anno=$genes, groups=genotype, samples=1:7, status=results[,2], main="md plot: Wild-type vs Smchd1", display.columns=c("symbols", "GeneID", "GeneName"), folder="smchd1-lymphoma") glmdplot.default Glimma MD Plot Draw an interactive MD plot from a data.frame ## Default S3 method: glmdplot(, val, yval, counts = NULL, anno = NULL, groups, samples = NULL, status = rep(0, nrow()), transform = TRUE, side.lab = "Group", side.ylab = "logcpm", side.log = FALSE, side.gridstep = ifelse(!transform side.log, FALSE, 0.5), lab = val, ylab = yval, search.by = "Symbols", jitter = 30, id.column = "GeneID", display.columns = id.column, cols = c("#0000ff", "#858585", "#B32222"), sample.cols = rep("#1f77b4", ncol(counts)), table = TRUE, path = getwd(), folder = "glimma-plots", html = "MD-Plot", launch = TRUE,...) val yval counts anno groups the data.frame object containing epression and fold change values. the column to plot on ais of left plot. the column to plot on y ais of left plot. the matri containing all counts. the data.frame containing gene annotations. the factor containing eperimental groups of the samples.

9 glmdplot.default 9 samples status transform side.lab side.ylab side.log side.gridstep lab ylab search.by jitter id.column the names of the samples. vector giving the control status of data point, of same length as the number of rows of object. If NULL, then all points are plotted in the default colour. TRUE if counts are raw and should be cpm transformed, FALSE if counts are already transformed to epression scale. label for ais on right side plot. label for y ais on right side plot. TRUE to plot epression on the side plot on log scale. intervals along which to place grid lines on y ais. Currently only available for linear scale. the label on the ais for the left plot. the label on the y ais for the left plot. the name of the column which will be used to search for data points if table is not used. (should contain unique values) the amount of jitter to apply to the samples in the epressions plot. the column containing unique identifiers for each gene. display.columns character vector containing names of columns to display in mouseover tooltips and table. cols vector of strings denoting colours corresponding to control status -1, 0 and 1. (may be R named colours or He values) sample.cols table path folder html launch vector of strings denoting colours for each sample point on the epression plot. logical variable for whether a table of the data should appear on the bottom of the HTML page. the path in which the folder will be created. the name of the fold to save html file to. the name of the html file to save plots to. TRUE to launch plot after call.... additional arguments to be passed onto the MD plot. (main, lab, ylab can be set for the left plot) Draws a two-panel interactive MD plot in an html page. The left plot shows the log-fold-change vs average epression. The right plot shows the epression levels of a particular gene of each sample. Hovering over points on left plot will plot epression level for corresponding gene, clicking on points will fi the epression plot to gene. Clicking on rows on the table has the same effect as clicking on the corresponding gene in the plot. Shian Su

10 10 glmdplot.deseqdataset glmdplot.deseqdataset Glimma MD Plot Draw an interactive MD plot from a DESeqDataSet object ## S3 method for class 'DESeqDataSet' glmdplot(, anno, groups, samples, status = rep(0, nrow()), transform = TRUE, side.lab = "Group", side.ylab = "logmean", side.log = FALSE, side.gridstep = ifelse(!transform side.log, FALSE, 0.5), search.by = "Symbols", jitter = 30, id.column = "GeneID", display.columns = NULL, cols = c("#0000ff", "#858585", "#B32222"), sample.cols = rep("#1f77b4", ncol()), table = TRUE, path = getwd(), folder = "glimma-plots", html = "MD-Plot", launch = TRUE,...) anno groups samples status transform side.lab side.ylab side.log side.gridstep search.by jitter the DESeqDataSet object. the data.frame containing gene annotations. the factor containing eperimental groups of the samples. the names of the samples. vector giving the control status of data point, of same length as the number of rows of object. If NULL, then all points are plotted in the default colour. TRUE if counts are raw and should be cpm transformed, FALSE if counts are already transformed to epression scale. label for ais on right side plot. label for y ais on right side plot. TRUE to plot epression on the side plot on log scale. intervals along which to place grid lines on y ais. Currently only available for linear scale. the name of the column which will be used to search for data points. (should contain unique values) the amount of jitter to apply to the samples in the epressions plot. id.column the column containing unique identifiers for each gene. display.columns character vector containing names of columns to display in mouseover tooltips and table. cols vector of strings denoting colours corresponding to control status -1, 0 and 1. (may be R named colours or He values) sample.cols table path vector of strings denoting colours for each sample point on the epression plot. logical variable for whether a table of the data should appear on the bottom of the HTML page. the path in which the folder will be created.

11 glmdplot.deseqresults 11 folder html launch the name of the fold to save html file to. the name of the html file to save plots to. TRUE to launch plot after call.... additional arguments to be passed onto the MD plot. (main, lab, ylab can be set for the left plot) Draws a two-panel interactive MD plot in an html page. The left plot shows the log-fold-change vs average epression. The right plot shows the epression levels of a particular gene of each sample. Hovering over points on left plot will plot epression level for corresponding gene, clicking on points will fi the epression plot to gene. Clicking on rows on the table has the same effect as clicking on the corresponding gene in the plot. Shian Su glmdplot.deseqresults Glimma MD Plot Draw an interactive MD plot from a DESeqResults object ## S3 method for class 'DESeqResults' glmdplot(, counts, anno, groups, samples, status = rep(0, nrow()), transform = TRUE, side.lab = "Group", side.ylab = "logcpm", side.log = FALSE, side.gridstep = ifelse(!transform side.log, FALSE, 0.5), search.by = "Symbols", jitter = 30, id.column = "GeneID", display.columns = NULL, cols = c("#0000ff", "#858585", "#B32222"), sample.cols = rep("#1f77b4", ncol(counts)), table = TRUE, path = getwd(), folder = "glimma-plots", html = "MD-Plot", launch = TRUE,...) counts anno groups samples status transform the DESeqResults object. the matri containing all counts. the data.frame containing gene annotations. the factor containing eperimental groups of the samples. the names of the samples. vector giving the control status of data point, of same length as the number of rows of object. If NULL, then all points are plotted in the default colour. TRUE if counts are raw and should be cpm transformed, FALSE if counts are already transformed to epression scale.

12 12 glmdplot.dgeeact side.lab side.ylab side.log side.gridstep search.by jitter id.column label for ais on right side plot. label for y ais on right side plot. TRUE to plot epression on the side plot on log scale. intervals along which to place grid lines on y ais. Currently only available for linear scale. the name of the column which will be used to search for data points. (should contain unique values) the amount of jitter to apply to the samples in the epressions plot. the column containing unique identifiers for each gene. display.columns character vector containing names of columns to display in mouseover tooltips and table. cols vector of strings denoting colours corresponding to control status -1, 0 and 1. (may be R named colours or He values) sample.cols table path folder html launch vector of strings denoting colours for each sample point on the epression plot. logical variable for whether a table of the data should appear on the bottom of the HTML page. the path in which the folder will be created. the name of the fold to save html file to. the name of the html file to save plots to. TRUE to launch plot after call.... additional arguments to be passed onto the MD plot. (main, lab, ylab can be set for the left plot) Draws a two-panel interactive MD plot in an html page. The left plot shows the log-fold-change vs average epression. The right plot shows the epression levels of a particular gene of each sample. Hovering over points on left plot will plot epression level for corresponding gene, clicking on points will fi the epression plot to gene. Clicking on rows on the table has the same effect as clicking on the corresponding gene in the plot. Shian Su glmdplot.dgeeact Glimma MD Plot Draw an interactive MD plot from a DGELRT objet

13 glmdplot.dgeeact 13 ## S3 method for class 'DGEEact' glmdplot(, counts = NULL, anno = NULL, groups = rep(0, ncol()), samples = NULL, status = rep(0, nrow()), transform = TRUE, side.lab = "Group", side.ylab = "logcpm", side.log = FALSE, side.gridstep = ifelse(!transform side.log, FALSE, 0.5), p.adj.method = "BH", search.by = "Symbols", jitter = 30, id.column = "GeneID", display.columns = NULL, cols = c("#0000ff", "#858585", "#B32222"), sample.cols = rep("#1f77b4", ncol(counts)), table = TRUE, path = getwd(), folder = "glimma-plots", html = "MD-Plot", launch = TRUE,...) counts anno groups samples status transform side.lab side.ylab side.log side.gridstep p.adj.method search.by jitter the DGEEact object. the matri containing all counts. the data.frame containing gene annotations. the factor containing eperimental groups of the samples. the names of the samples. vector giving the control status of data point, of same length as the number of rows of object. If NULL, then all points are plotted in the default colour. TRUE if counts are raw and should be cpm transformed, FALSE if counts are already transformed to epression scale. label for ais on right side plot. label for y ais on right side plot. TRUE to plot epression on the side plot on log scale. intervals along which to place grid lines on y ais. Currently only available for linear scale. character vector indicating multiple testing correction method. (defaults to "BH") the name of the column which will be used to search for data points. (should contain unique values) the amount of jitter to apply to the samples in the epressions plot. id.column the column containing unique identifiers for each gene. display.columns character vector containing names of columns to display in mouseover tooltips and table. cols vector of strings denoting colours corresponding to control status -1, 0 and 1. (may be R named colours or He values) sample.cols table path folder html launch vector of strings denoting colours for each sample point on the epression plot. logical variable for whether a table of the data should appear on the bottom of the HTML page. the path in which the folder will be created. the name of the fold to save html file to. the name of the html file to save plots to. TRUE to launch plot after call.... additional arguments to be passed onto the MD plot. (main, lab, ylab can be set for the left plot)

14 14 glmdplot.dgelrt Draws a two-panel interactive MD plot in an html page. The left plot shows the log-fold-change vs average epression. The right plot shows the epression levels of a particular gene of each sample. Hovering over points on left plot will plot epression level for corresponding gene, clicking on points will fi the epression plot to gene. Clicking on rows on the table has the same effect as clicking on the corresponding gene in the plot. Shian Su glmdplot.dgelrt Glimma MD Plot Draw an interactive MD plot from a DGELRT object ## S3 method for class 'DGELRT' glmdplot(, counts = NULL, anno = NULL, groups = rep(0, ncol()), samples = NULL, status = rep(0, nrow()), transform = TRUE, side.lab = "Group", side.ylab = "logcpm", side.log = FALSE, side.gridstep = ifelse(!transform side.log, FALSE, 0.5), p.adj.method = "BH", search.by = "Symbols", jitter = 30, id.column = "GeneID", display.columns = NULL, cols = c("#0000ff", "#858585", "#B32222"), sample.cols = rep("#1f77b4", ncol(counts)), table = TRUE, path = getwd(), folder = "glimma-plots", html = "MD-Plot", launch = TRUE,...) counts anno groups samples status transform side.lab side.ylab side.log side.gridstep the DGELRT object. the matri containing all counts. the data.frame containing gene annotations. the factor containing eperimental groups of the samples. the names of the samples. vector giving the control status of data point, of same length as the number of rows of object. If NULL, then all points are plotted in the default colour. TRUE if counts are raw and should be cpm transformed, FALSE if counts are already transformed to epression scale. label for ais on right side plot. label for y ais on right side plot. TRUE to plot epression on the side plot on log scale. intervals along which to place grid lines on y ais. Currently only available for linear scale.

15 glmdplot.marraylm 15 p.adj.method character vector indicating multiple testing correction method. (defaults to "BH") search.by the name of the column which will be used to search for data points. (should contain unique values) jitter the amount of jitter to apply to the samples in the epressions plot. id.column the column containing unique identifiers for each gene. display.columns character vector containing names of columns to display in mouseover tooltips and table. cols vector of strings denoting colours corresponding to control status -1, 0 and 1. (may be R named colours or He values) sample.cols vector of strings denoting colours for each sample point on the epression plot. table logical variable for whether a table of the data should appear on the bottom of the HTML page. path the path in which the folder will be created. folder the name of the fold to save html file to. html the name of the html file to save plots to. launch TRUE to launch plot after call.... additional arguments to be passed onto the MD plot. (main, lab, ylab can be set for the left plot) Draws a two-panel interactive MD plot in an html page. The left plot shows the log-fold-change vs average epression. The right plot shows the epression levels of a particular gene of each sample. Hovering over points on left plot will plot epression level for corresponding gene, clicking on points will fi the epression plot to gene. Clicking on rows on the table has the same effect as clicking on the corresponding gene in the plot. Shian Su glmdplot.marraylm Glimma MD Plot Draw an interactive MD plot from a MArrayLM object ## S3 method for class 'MArrayLM' glmdplot(, counts = NULL, anno = NULL, groups = rep(0, ncol()), samples = NULL, status = rep(0, nrow()), transform = TRUE, side.lab = "Group", side.ylab = "logcpm", side.log = FALSE, side.gridstep = ifelse(!transform side.log, FALSE, 0.5), coef = ncol($coefficients), p.adj.method = "BH", search.by = "Symbols", jitter = 30, id.column = "GeneID", display.columns = NULL, cols = c("#0000ff", "#858585", "#B32222"), sample.cols = rep("#1f77b4", ncol(counts)), table = TRUE, path = getwd(), folder = "glimma-plots", html = "MD-Plot", launch = TRUE,...)

16 16 glmdplot.marraylm counts anno groups samples status transform side.lab side.ylab side.log side.gridstep coef p.adj.method search.by jitter the MArrayLM object. the matri containing all counts. the data.frame containing gene annotations. the factor containing eperimental groups of the samples. the names of the samples. vector giving the control status of data point, of same length as the number of rows of object. If NULL, then all points are plotted in the default colour. TRUE if counts are raw and should be cpm transformed, FALSE if counts are already transformed to epression scale. label for ais on right side plot. label for y ais on right side plot. TRUE to plot epression on the side plot on log scale. intervals along which to place grid lines on y ais. Currently only available for linear scale. integer or character inde vector indicating which column of object to plot. character vector indicating multiple testing correction method. (defaults to "BH") the name of the column which will be used to search for data points. (should contain unique values) the amount of jitter to apply to the samples in the epressions plot. id.column the column containing unique identifiers for each gene. display.columns character vector containing names of columns to display in mouseover tooltips and table. cols vector of strings denoting colours corresponding to control status -1, 0 and 1. (may be R named colours or He values) sample.cols table path folder html launch vector of strings denoting colours for each sample point on the epression plot. logical variable for whether a table of the data should appear on the bottom of the HTML page. the path in which the folder will be created. the name of the fold to save html file to. the name of the html file to save plots to. TRUE to launch plot after call.... additional arguments to be passed onto the MD plot. (main, lab, ylab can be set for the left plot) Draws a two-panel interactive MD plot in an html page. The left plot shows the log-fold-change vs average epression. The right plot shows the epression levels of a particular gene of each sample. Hovering over points on left plot will plot epression level for corresponding gene, clicking on points will fi the epression plot to gene. Clicking on rows on the table has the same effect as clicking on the corresponding gene in the plot.

17 glmdsplot 17 Shian Su Eamples library(limma) library(edger) data(lymphomarnaseq) <- lymphomarnaseq sel <- rowsums(cpm($counts)>0.5)>=3 <- [sel,] genotype <- relevel($samples$group, "Smchd1-null") <- calcnormfactors(, method="tmm") des <- model.matri(~genotype) ## Apply voom with sample quality weights and fit linear model v <- voomwithqualityweights(, design=des, normalization="none", plot=false) vfit <- lmfit(v,des) ## Apply treat relative to a fold-change of 1.5 vtfit <- treat(vfit,lfc=log2(1.5)) vfit <- ebayes(vfit) results <- decidetests(vfit,p.value=0.01) glmdplot(vfit, counts=$counts, anno=$genes, groups=genotype, samples=1:7, status=results[,2], main="md plot: Wild-type vs Smchd1", display.columns=c("symbols", "GeneID", "GeneName"), folder="smchd1-lymphoma") glmdsplot Glimma MDS Plot Draw an interactive MDS plot gene epression matri with distances calculated from most variable genes. glmdsplot(,...) the data.frame containing data to plot.... additional arguments affecting the plots produced. See specific methods for detailed arguments.

18 18 glmdsplot.default Draws a two-panel interactive MDS plot in an html page. The left panel contains the plot between two MDS dimensions, with annotations displayed on hover. The right panel contains a bar plot of the eigenvalues of each dimension, clicking on any of the bars will plot the corresponding dimension against the net dimension. See Also Shian Su, Gordon Smyth glmdsplot.default, glmdsplot.dgelist Eamples data(lymphomarnaseq) genotype <- relevel(lymphomarnaseq$samples$group, "Smchd1-null") glmdsplot(lymphomarnaseq, labels=1:7, groups=genotype) glmdsplot.default Glimma MDS Plot Draw an interactive MDS plot from a gene epression matri with distances calculated from most variable genes. ## Default S3 method: glmdsplot(, top = 500, labels = 1:ncol(), groups = rep(1, ncol()), gene.selection = "pairwise", main = "MDS Plot", path = getwd(), folder = "glimma-plots", html = "MDS-Plot", launch = TRUE,...) top labels groups the matri containing the gene epressions. the number of top most variable genes to use. the labels for each sample. the eperimental group to which samples belong. gene.selection "pairwise" if most variable genes are to be chosen for each pair of samples or "common" to select the same genes for all comparisons. main path folder the title of the plot. the path in which the folder will be created. the name of the fold to save html file to.

19 glmdsplot.dgelist 19 html the name of the html file to save plots to. launch TRUE to launch plot after call.... additional arguments. Draws a two-panel interactive MDS plot in an html page. The left panel contains the plot between two MDS dimensions, with annotations displayed on hover. The right panel contains a bar plot of the eigenvalues of each dimension, clicking on any of the bars will plot the corresponding dimension against the net dimension. Shian Su, Gordon Smyth glmdsplot.dgelist Glimma MDS Plot Draw an interactive MD plot from a DGEList object with distances calculated from most variable genes. ## S3 method for class 'DGEList' glmdsplot(, top = 500, labels = 1:ncol(), groups = rep(1, ncol()), gene.selection = "pairwise", main = "MDS Plot", path = getwd(), folder = "glimma-plots", html = "MDS-Plot", launch = TRUE,...) top labels groups the DGEList containing the gene epressions. the number of top most variable genes to use. the labels for each sample. the eperimental group to which samples belong. gene.selection "pairwise" if most variable genes are to be chosen for each pair of samples or "common" to select the same genes for all comparisons. main path folder html launch the title of the plot. the path in which the folder will be created. the name of the fold to save html file to. the name of the html file to save plots to. TRUE to launch plot after call.... additional arguments.

20 20 glscatter Draws a two-panel interactive MDS plot in an html page. The left panel contains the plot between two MDS dimensions, with annotations displayed on hover. The right panel contains a bar plot of the eigenvalues of each dimension, clicking on any of the bars will plot the corresponding dimension against the net dimension. Shian Su, Gordon Smyth glscatter Glimma Scatter Plot Create an interactive scatter plot object glscatter(,...) the data.frame containing data to plot.... additional arguments depending on input object type. A chart object containing the information to create an interactive scatter plot. Shian Su Eamples data(iris) plot1 <- glscatter(iris, val="sepal.length", yval="sepal.width", colval="species") glimma(plot1, c(1,1))

21 glscatter.default 21 glscatter.default Glimma Scatter Plot Default method for creating an interactive scatter plot ## Default S3 method: glscatter(, val = "", yval = "y", idval = NULL, point.size = 2,.jitter = 0, y.jitter = 0, ndigits = NULL, signif = 6, log = "", grid = FALSE, ygrid = FALSE, step = FALSE, ystep = FALSE, lab = val, ylab = yval, main = NULL, height = 400, width = 500, colval = NULL, annot = c(val, yval), annot.lab = NULL, flag = NULL, info = NULL, hide = FALSE, disable = NULL,...) the data.frame containing data to plot. val the column name for the -ais values. yval the column name for the y-ais values. idval the column name for unique identifiers. point.size the size of the data points..jitter the amount of jittering to add to values along the ais. y.jitter the amount of jittering to add to values along the y ais. ndigits the number of digits after the decimal to round to in the tooltip (overrides signif). signif the number of significant figures to display in the tooltip. log a character string which contains "" if the ais is to be logarithmic, "y" if the y ais is to be logarithmic and "y" or "y" if both aes are to be logarithmic. grid TRUE if grid lines should be placed along ais. ygrid TRUE if grid lines should be placed y ais. step the interval at which to set grid lines along the ais. ystep the interval at which to set grid lines along the y ais. lab the label on the -ais. ylab the label on the y-ais. main the title for the plot. height the height of the plot (in piels). width the width of the plot (in piels). colval the colours for each data point. annot the columns to display in the tooltip. annot.lab alternative labels for the values displayed in the tooltip. flag the special flag to indicate special plot. info additional information for plotting. hide TRUE to hide the plot when page starts. disable the events to disable, options are "click", "hover", "zoom".... additional arguments.

22 22 gltablink A chart object containing the information to create an interactive scatter plot. Shian Su Eamples data(iris) plot1 <- glscatter(iris, val="sepal.length", yval="sepal.width", colval="species") glimma(plot1, c(1,1)) gltable Glimma Table Create a table using the data from a chart. gltable(target, columns) target columns the inde of the plot from which data is drawn. the columns of data to plot. a input object containing the input field information. gltablink Plot linkages Helper function for writing the link properties in interactive Glimma plots gltablink(from, to, action = "none", info = "none")

23 glxyplot 23 from to action info the inde of the source table. the inde of the plot which receives the event and performs an action. the action that is performed in the plot. additional info for creating the link. a link object containing the plot linking information. glxyplot Glimma XY Plot Draw an interactive XY plot with multiple panels glxyplot(, y, counts = NULL, groups = NULL, samples = NULL, status = rep(0, nrow(data)), anno = NULL, display.columns = NULL, id.column = "GeneID", lab = "", ylab = "y", side.lab = "Group", side.ylab = "logcpm", sample.cols = rep("#1f77b4", length(groups)), cols = c("#0000ff", "#858585", "#B32222"), jitter = 30, path = getwd(), folder = "glimma-plots", html = "XY-Plot", launch = TRUE,...) y counts groups samples status a numeric vector of values to plot on the -ais of the summary plot. a numeric vector of values to plot on the y-ais of the summary plot. the matri containing all counts. the factor containing eperimental groups of the samples. the names of the samples. vector giving the control status of data point, of same length as the number of rows of object. If NULL, then all points are plotted in the default colou anno the data.frame containing gene annotations. display.columns character vector containing names of columns to display in mouseover tooltips and table. id.column lab ylab side.lab side.ylab sample.cols the column containing unique identifiers for each gene. the label on the ais for the left plot. the label on the y ais for the left plot. the label on the ais for the right plot. the label on the y ais for the right plot. vector of strings denoting colours for each sample point on the epression plot.

24 24 hascolumns cols vector of strings denoting colours corresponding to control status -1, 0 and 1. (may be R named colours or He values) jitter path folder html launch the amount of jitter to apply to the samples in the epressions plot. the path in which the folder will be created. the name of the fold to save html file to. the name of the html file to save plots to. TRUE to launch plot after call.... additional arguments to be passed onto the MD plot. (main, etc. can be set for the left plot) Draws a two-panel interactive XY scatter plot in an html page. The left plot shows the and y values specified. The right plot shows the epression levels of a particular gene in each sample. Hovering over points on left plot will plot epression level for the corresponding gene, clicking on points will fi the epression plot to that gene. Clicking on rows on the table has the same effect as clicking on the corresponding gene in the plot. This function generates a display that is similar in style to glmdplot, ecept that it provides more fleibility in what the user can provide. Charity Law and Shian Su Eamples data(iris) glxyplot(iris$sepal.width, iris$sepal.length, lab="sepal.width", ylab="sepal.length", id.column="plantid") hascolumns Column checker Check if data.frame controls all the listed columns hascolumns(df, columns) df columns the data frame to check. the columns that should eist in the data frame. stops program with an error if column cannot be found in df

25 lymphomarnaseq 25 lymphomarnaseq Mouse based RNAseq data for study of smchd1 gene. Mouse based RNAseq data for study of smchd1 gene. Ruijie Liu, Kelan Chen, Natasha Jansz, Marnie E. Blewitt, Matthew E. Ritchie References makejson.chart JSON converter for chart objects Function to make json object from a chart, ignoring the json property ## S3 method for class 'chart' makejson(chart) chart the chart object to be converted into JSON a stringified JSON object containing the chart data.

26 26 NumToHeCol makejson.data.frame JSON converter for data frames Function to create a JSON from a data.frame ## S3 method for class 'data.frame' makejson(df, convert.logical = TRUE) df the data.frame to be converted into JSON convert.logical whether to convert logicals into strings "TRUE" and "FALSE" a stringified JSON, the data.frame is encoded as a vector of objects, with each column being one object with keys corresponding to column names. NumToHeCol Numeric to he colour converter Functions to convert numbers into corresponding he codes for colours NumToHeCol() the colour value(s) to be converted to he values. he codes for colours

27 Inde Topic RNAseq lymphomarnaseq, 25 as.hecol, 2 CharToHeCol, 3 glautoinput, 3 glbar, 4 glbar.default, 4, 4 glimma, 5 gllink, 6 glmdplot, 7 glmdplot.default, 7, 8 glmdplot.deseqdataset, 7, 10 glmdplot.deseqresults, 11 glmdplot.dgeeact, 7, 12 glmdplot.dgelrt, 7, 14 glmdplot.marraylm, 7, 15 glmdsplot, 17 glmdsplot.default, 18, 18 glmdsplot.dgelist, 18, 19 glscatter, 20 glscatter.default, 21 gltable, 22 gltablink, 22 glxyplot, 23 hascolumns, 24 lymphomarnaseq, 25 makejson.chart, 25 makejson.data.frame, 26 NumToHeCol, 26 27

Package Glimma. June 29, 2018

Package Glimma. June 29, 2018 Type Package Title Interactive HTML graphics Version 1.8.2 Date 2016-12-21 Package Glimma June 29, 2018 This package generates interactive visualisations for analysis of RNA-sequencing data using output

More information

Glimma: Interactive Graphics for RNA-seq Analyses

Glimma: Interactive Graphics for RNA-seq Analyses Glimma: Interactive Graphics for RNA-seq Analyses User s Guide Shian Su, Charity W. Law, Matthew E. Ritchie First edition 28 January 2016 Last revised 30 October 2017 1 Contents 1 Quick start 3 2 Creating

More information

Package pairsd3. R topics documented: August 29, Title D3 Scatterplot Matrices Version 0.1.0

Package pairsd3. R topics documented: August 29, Title D3 Scatterplot Matrices Version 0.1.0 Title D3 Scatterplot Matrices Version 0.1.0 Package pairsd3 August 29, 2016 Creates an interactive scatterplot matrix using the D3 JavaScript library. See for more information on D3.

More information

Package pandar. April 30, 2018

Package pandar. April 30, 2018 Title PANDA Algorithm Version 1.11.0 Package pandar April 30, 2018 Author Dan Schlauch, Joseph N. Paulson, Albert Young, John Quackenbush, Kimberly Glass Maintainer Joseph N. Paulson ,

More information

Package zebu. R topics documented: October 24, 2017

Package zebu. R topics documented: October 24, 2017 Type Package Title Local Association Measures Version 0.1.2 Date 2017-10-21 Author Olivier M. F. Martin [aut, cre], Michel Ducher [aut] Package zebu October 24, 2017 Maintainer Olivier M. F. Martin

More information

Package biomformat. April 11, 2018

Package biomformat. April 11, 2018 Version 1.7.0 Date 2016-04-16 Package biomformat April 11, 2018 Maintainer Paul J. McMurdie License GPL-2 Title An interface package for the BIOM file format Type Package Author

More information

Package narray. January 28, 2018

Package narray. January 28, 2018 Package narray January 28, 2018 Title Subset- And Name-Aware Array Utility Functions Version 0.4.0 Author Michael Schubert Maintainer Michael Schubert Stacking

More information

Package anota2seq. January 30, 2018

Package anota2seq. January 30, 2018 Version 1.1.0 Package anota2seq January 30, 2018 Title Generally applicable transcriptome-wide analysis of translational efficiency using anota2seq Author Christian Oertlin , Julie

More information

Package smoothr. April 4, 2018

Package smoothr. April 4, 2018 Type Package Title Smooth and Tidy Spatial Features Version 0.1.0 Package smoothr April 4, 2018 Tools for smoothing and tidying spatial features (i.e. lines and polygons) to make them more aesthetically

More information

Package gggenes. R topics documented: November 7, Title Draw Gene Arrow Maps in 'ggplot2' Version 0.3.2

Package gggenes. R topics documented: November 7, Title Draw Gene Arrow Maps in 'ggplot2' Version 0.3.2 Title Draw Gene Arrow Maps in 'ggplot2' Version 0.3.2 Package gggenes November 7, 2018 Provides a 'ggplot2' geom and helper functions for drawing gene arrow maps. Depends R (>= 3.3.0) Imports grid (>=

More information

Package HTSFilter. November 30, 2017

Package HTSFilter. November 30, 2017 Type Package Package HTSFilter November 30, 2017 Title Filter replicated high-throughput transcriptome sequencing data Version 1.18.0 Date 2017-07-26 Author Andrea Rau, Melina Gallopin, Gilles Celeux,

More information

Package LaF. November 20, 2017

Package LaF. November 20, 2017 Type Package Title Fast Access to Large ASCII Files Version 0.8.0 Date 2017-11-16 Author Jan van der Laan Package LaF November 20, 2017 Maintainer Jan van der Laan Methods

More information

Package kdetrees. February 20, 2015

Package kdetrees. February 20, 2015 Type Package Package kdetrees February 20, 2015 Title Nonparametric method for identifying discordant phylogenetic trees Version 0.1.5 Date 2014-05-21 Author and Ruriko Yoshida Maintainer

More information

Package meme. November 2, 2017

Package meme. November 2, 2017 Title Create Meme Version 0.0.7 Package meme November 2, 2017 The word 'Meme' was originated from the book, 'The Selfish Gene', authored by Richard Dawkins (1976). It is a unit of culture that is passed

More information

CQN (Conditional Quantile Normalization)

CQN (Conditional Quantile Normalization) CQN (Conditional Quantile Normalization) Kasper Daniel Hansen khansen@jhsph.edu Zhijin Wu zhijin_wu@brown.edu Modified: August 8, 2012. Compiled: April 30, 2018 Introduction This package contains the CQN

More information

Package meme. December 6, 2017

Package meme. December 6, 2017 Title Create Meme Version 0.1.1 Package meme December 6, 2017 The word 'Meme' was originated from the book, 'The Selfish Gene', authored by Richard Dawkins (1976). It is a unit of culture that is passed

More information

Package geojsonsf. R topics documented: January 11, Type Package Title GeoJSON to Simple Feature Converter Version 1.3.

Package geojsonsf. R topics documented: January 11, Type Package Title GeoJSON to Simple Feature Converter Version 1.3. Type Package Title GeoJSON to Simple Feature Converter Version 1.3.0 Date 2019-01-11 Package geojsonsf January 11, 2019 Converts Between GeoJSON and simple feature objects. License GPL-3 Encoding UTF-8

More information

Package INCATome. October 5, 2017

Package INCATome. October 5, 2017 Type Package Package INCATome October 5, 2017 Title Internal Control Analysis of Translatome Studies by Microarrays Version 1.0 Date 2017-10-03 Author Sbarrato T. [cre,aut], Spriggs R.V. [cre,aut], Wilson

More information

Package omicade4. June 29, 2018

Package omicade4. June 29, 2018 Type Package Title Multiple co-inertia analysis of omics datasets Version 1.20.0 Date 2017-04-24 Package omicade4 June 29, 2018 Author, Aedin Culhane, Amin M. Gholami. Maintainer

More information

Package EMDomics. November 11, 2018

Package EMDomics. November 11, 2018 Package EMDomics November 11, 2018 Title Earth Mover's Distance for Differential Analysis of Genomics Data The EMDomics algorithm is used to perform a supervised multi-class analysis to measure the magnitude

More information

Package manta. R topics documented: October 6, Version Date

Package manta. R topics documented: October 6, Version Date Version 1.26.0 Date 2012-03-15 Package manta October 6, 2018 Title Microbial Assemblage Normalized Transcript Analysis Author Ginger Armbrust, Adrian Marchetti Maintainer Chris Berthiaume ,

More information

Package scatterd3. March 10, 2018

Package scatterd3. March 10, 2018 Type Package Title D3 JavaScript Scatterplot from R Version 0.8.2 Date 2018-03-09 Package scatterd3 March 10, 2018 Maintainer Julien Barnier Description Creates 'D3' 'JavaScript'

More information

Package customlayout

Package customlayout Type Package Package customlayout October 31, 2018 Title Arrange Elements on the R's Drawing Area or Inside the PowerPoint's Slide Version 0.3.0 Maintainer Zygmunt Zawadzki Create complicated

More information

Package enrichplot. September 29, 2018

Package enrichplot. September 29, 2018 Package enrichplot September 29, 2018 Title Visualization of Functional Enrichment Result Version 1.1.7 The 'enrichplot' package implements several visualization methods for interpreting functional enrichment

More information

Package Mondrian. R topics documented: March 4, Type Package

Package Mondrian. R topics documented: March 4, Type Package Type Package Package Mondrian March 4, 2016 Title A Simple Graphical Representation of the Relative Occurrence and Co-Occurrence of Events The unique function of this package allows representing in a single

More information

Package rafalib. R topics documented: August 29, Version 1.0.0

Package rafalib. R topics documented: August 29, Version 1.0.0 Version 1.0.0 Package rafalib August 29, 2016 Title Convenience Functions for Routine Data Eploration A series of shortcuts for routine tasks originally developed by Rafael A. Irizarry to facilitate data

More information

Package ssizerna. January 9, 2017

Package ssizerna. January 9, 2017 Type Package Package ssizerna January 9, 2017 Title Sample Size Calculation for RNA-Seq Experimental Design Version 1.2.9 Date 2017-01-05 Maintainer Ran Bi We propose a procedure for

More information

Package superbiclust

Package superbiclust Type Package Package superbiclust February 20, 2015 Title Generating Robust Biclusters from a Bicluster Set (Ensemble Biclustering) Version 1.1 Date 2012-08-23 Author Maintainer

More information

Package canvasxpress

Package canvasxpress Version 1.18.2 Package canvasxpress Title Visualization Package for CanvasXpress in R January 19, 2018 Enables creation of visualizations using the CanvasXpress framework in R. CanvasXpress is a standalone

More information

Package RNASeqR. January 8, 2019

Package RNASeqR. January 8, 2019 Type Package Package RNASeqR January 8, 2019 Title RNASeqR: RNA-Seq workflow for case-control study Version 1.1.3 Date 2018-8-7 Author Maintainer biocviews Genetics, Infrastructure,

More information

Package spark. July 21, 2017

Package spark. July 21, 2017 Title 'Sparklines' in the 'R' Terminal Version 2.0.0 Author Gábor Csárdi Package spark July 21, 2017 Maintainer Gábor Csárdi A 'sparkline' is a line chart, without axes and labels.

More information

Package PathoStat. February 25, 2018

Package PathoStat. February 25, 2018 Type Package Package PathoStat February 25, 2018 Title PathoStat Statistical Microbiome Analysis Package Version 1.5.1 Date 2017-12-06 Author Solaiappan Manimaran , Matthew

More information

Package RTNduals. R topics documented: March 7, Type Package

Package RTNduals. R topics documented: March 7, Type Package Type Package Package RTNduals March 7, 2019 Title Analysis of co-regulation and inference of 'dual regulons' Version 1.7.0 Author Vinicius S. Chagas, Clarice S. Groeneveld, Gordon Robertson, Kerstin B.

More information

Package ClusterSignificance

Package ClusterSignificance Package ClusterSignificance May 11, 2018 Title The ClusterSignificance package provides tools to assess if class clusters in dimensionality reduced data representations have a separation different from

More information

Package Director. October 15, 2018

Package Director. October 15, 2018 Package Director October 15, 2018 Title A dynamic visualization tool of multi-level data Version 1.7.3 Author Katherine Icay [aut, cre] Maintainer Katherine Icay Director is

More information

Package accrued. R topics documented: August 24, Type Package

Package accrued. R topics documented: August 24, Type Package Type Package Package accrued August 24, 2016 Title Data Quality Visualization Tools for Partially Accruing Data Version 1.4.1 Date 2016-06-07 Author Julie Eaton and Ian Painter Maintainer Julie Eaton

More information

Package msda. February 20, 2015

Package msda. February 20, 2015 Title Multi-Class Sparse Discriminant Analysis Version 1.0.2 Date 2014-09-26 Package msda February 20, 2015 Author Maintainer Yi Yang Depends Matri, MASS Efficient procedures for computing

More information

Package mschart. April 20, Type Package

Package mschart. April 20, Type Package Type Package Package mschart April 20, 2018 Title Chart Generation for 'Microsoft Word' and 'Microsoft PowerPoint' Documents Version 0.2.3 Create native charts for 'Microsoft PowerPoint' and 'Microsoft

More information

Package graphframes. June 21, 2018

Package graphframes. June 21, 2018 Type Package Title Interface for 'GraphFrames' Version 0.1.1 Package graphframes June 21, 2018 Maintainer Kevin Kuo A 'sparklyr' etension that provides

More information

Package naivebayes. R topics documented: January 3, Type Package. Title High Performance Implementation of the Naive Bayes Algorithm

Package naivebayes. R topics documented: January 3, Type Package. Title High Performance Implementation of the Naive Bayes Algorithm Package naivebayes January 3, 2018 Type Package Title High Performance Implementation of the Naive Bayes Algorithm Version 0.9.2 Author Michal Majka Maintainer Michal Majka Description

More information

Package kdtools. April 26, 2018

Package kdtools. April 26, 2018 Type Package Package kdtools April 26, 2018 Title Tools for Working with Multidimensional Data Version 0.3.1 Provides various tools for working with multidimensional data in R and C++, including etremely

More information

Package MLP. February 12, 2018

Package MLP. February 12, 2018 Package MLP February 12, 2018 Maintainer Tobias Verbeke License GPL-3 Title MLP Type Package Author Nandini Raghavan, Tobias Verbeke, An De Bondt with contributions by

More information

Package collapsibletree

Package collapsibletree Type Package Package collapsibletree September 23, 2017 Title Interactive Collapsible Tree Diagrams using 'D3.js' Version 0.1.6 Maintainer Adeel Khan Description Interactive Reingold-Tilford

More information

Package sankey. R topics documented: October 22, 2017

Package sankey. R topics documented: October 22, 2017 Package sankey October 22, 2017 Title Illustrate the Flow of Information or Material Version 1.0.2 Author Gábor Csárdi, January Weiner Maintainer Gábor Csárdi Description Plots

More information

Package diggit. R topics documented: January 11, Version Date

Package diggit. R topics documented: January 11, Version Date Version 1.14.0 Date 2014-08-22 Package diggit January 11, 2019 Title Inference of Genetic Variants Driving Cellular Phenotypes Author Mariano J Alvarez Maintainer Mariano J Alvarez

More information

Package barcoder. October 26, 2018

Package barcoder. October 26, 2018 Package barcoder October 26, 2018 Title Labelling, Tracking, and Collecting Data from Biological Samples Version 0.1.0 Maintainer Robert Colautti Tools to generate unique identifiers

More information

Package EnQuireR. R topics documented: February 19, Type Package Title A package dedicated to questionnaires Version 0.

Package EnQuireR. R topics documented: February 19, Type Package Title A package dedicated to questionnaires Version 0. Type Package Title A package dedicated to questionnaires Version 0.10 Date 2009-06-10 Package EnQuireR February 19, 2015 Author Fournier Gwenaelle, Cadoret Marine, Fournier Olivier, Le Poder Francois,

More information

Practical: exploring RNA-Seq counts Hugo Varet, Julie Aubert and Jacques van Helden

Practical: exploring RNA-Seq counts Hugo Varet, Julie Aubert and Jacques van Helden Practical: exploring RNA-Seq counts Hugo Varet, Julie Aubert and Jacques van Helden 2016-11-24 Contents Requirements 2 Context 2 Loading a data table 2 Checking the content of the count tables 3 Factors

More information

Installation and Configuration Manual

Installation and Configuration Manual Installation and Configuration Manual IMPORTANT YOU MUST READ AND AGREE TO THE TERMS AND CONDITIONS OF THE LICENSE BEFORE CONTINUING WITH THIS PROGRAM INSTALL. CIRRUS SOFT LTD End-User License Agreement

More information

Package rgho. R topics documented: January 18, 2017

Package rgho. R topics documented: January 18, 2017 Package rgho January 18, 2017 Title Access WHO Global Health Observatory Data from R Version 1.0.1 Author Antoine Filipovic-Pierucci [aut,cre] Maintainer Antoine Filipovic-Pierucci

More information

Package ChIPseeker. July 12, 2018

Package ChIPseeker. July 12, 2018 Type Package Package ChIPseeker July 12, 2018 Title ChIPseeker for ChIP peak Annotation, Comparison, and Visualization Version 1.16.0 Encoding UTF-8 Maintainer Guangchuang Yu

More information

Package HomoVert. November 10, 2010

Package HomoVert. November 10, 2010 Package HomoVert November 10, 2010 Version 0.4.1 Date 2010-10-27 Title HomoVert: Functions to convert Gene IDs between species Author Matthew Fero Maintainer Matthew Fero

More information

Package slinky. March 15, 2019

Package slinky. March 15, 2019 Type Package Package slinky March 15, 2019 Title Putting the fun in LINCS L1000 data analysis Version 1.0.2 Date 2018-09 -21 Author Eric J. Kort Maintainer Eric J. Kort Wrappers to

More information

Package batchmeans. R topics documented: July 4, Version Date

Package batchmeans. R topics documented: July 4, Version Date Package batchmeans July 4, 2016 Version 1.0-3 Date 2016-07-03 Title Consistent Batch Means Estimation of Monte Carlo Standard Errors Author Murali Haran and John Hughes

More information

Package d3heatmap. February 1, 2018

Package d3heatmap. February 1, 2018 Type Package Package d3heatmap February 1, 2018 Title Interactive Heat Maps Using 'htmlwidgets' and 'D3.js' Version 0.6.1.2 Date 2016-02-23 Maintainer ORPHANED Description Create interactive heat maps

More information

Package bnbc. R topics documented: April 1, Version 1.4.0

Package bnbc. R topics documented: April 1, Version 1.4.0 Version 1.4.0 Package bnbc April 1, 2019 Title Bandwise normalization and batch correction of Hi-C data Tools to normalize (several) Hi-C data from replicates. Depends R (>= 3.4.0), methods, BiocGenerics,

More information

Package fuzzyreg. February 7, 2019

Package fuzzyreg. February 7, 2019 Title Fuzzy Linear Regression Version 0.5 Date 2019-02-06 Author Pavel Skrabanek [aut, cph], Natalia Martinkova [aut, cre, cph] Package fuzzyreg February 7, 2019 Maintainer Natalia Martinkova

More information

Package PCADSC. April 19, 2017

Package PCADSC. April 19, 2017 Type Package Package PCADSC April 19, 2017 Title Tools for Principal Component Analysis-Based Data Structure Comparisons Version 0.8.0 A suite of non-parametric, visual tools for assessing differences

More information

Package LncPath. May 16, 2016

Package LncPath. May 16, 2016 Type Package Package LncPath May 16, 2016 Title Identifying the Pathways Regulated by LncRNA Sets of Interest Version 1.0 Date 2016-04-27 Author Junwei Han, Zeguo Sun Maintainer Junwei Han

More information

Package datasets.load

Package datasets.load Title Interface for Loading Datasets Version 0.1.0 Package datasets.load December 14, 2016 Visual interface for loading datasets in RStudio from insted (unloaded) s. Depends R (>= 3.0.0) Imports shiny,

More information

Package dupradar. R topics documented: July 12, Type Package

Package dupradar. R topics documented: July 12, Type Package Type Package Package dupradar July 12, 2018 Title Assessment of duplication rates in RNA-Seq datasets Version 1.10.0 Date 2015-09-26 Author Sergi Sayols , Holger Klein

More information

Package lvec. May 24, 2018

Package lvec. May 24, 2018 Package lvec May 24, 2018 Type Package Title Out of Memory Vectors Version 0.2.2 Date 2018-05-23 Author Jan van der Laan Maintainer Jan van der Laan Core functionality

More information

Desktop Studio: Charts. Version: 7.3

Desktop Studio: Charts. Version: 7.3 Desktop Studio: Charts Version: 7.3 Copyright 2015 Intellicus Technologies This document and its content is copyrighted material of Intellicus Technologies. The content may not be copied or derived from,

More information

SIBER User Manual. Pan Tong and Kevin R Coombes. May 27, Introduction 1

SIBER User Manual. Pan Tong and Kevin R Coombes. May 27, Introduction 1 SIBER User Manual Pan Tong and Kevin R Coombes May 27, 2015 Contents 1 Introduction 1 2 Using SIBER 1 2.1 A Quick Example........................................... 1 2.2 Dealing With RNAseq Normalization................................

More information

Package panelview. April 24, 2018

Package panelview. April 24, 2018 Type Package Package panelview April 24, 2018 Title Visualizing Panel Data with Dichotomous Treatments Version 1.0.1 Date 2018-04-23 Author Licheng Liu, Yiqing Xu Maintainer Yiqing Xu

More information

Package condformat. October 19, 2017

Package condformat. October 19, 2017 Type Package Title Conditional Formatting in Data Frames Version 0.7.0 Date 2017-10-19 URL http://github.com/zeehio/condformat Package condformat October 19, 2017 BugReports http://github.com/zeehio/condformat/issues

More information

Package GSVA. R topics documented: January 22, Version

Package GSVA. R topics documented: January 22, Version Version 1.26.0 Package GSVA January 22, 2018 Title Gene Set Variation Analysis for microarray and RNA-seq data Depends R (>= 3.0.0) Imports methods, BiocGenerics, Biobase, GSEABase (>= 1.17.4), geneplotter,

More information

EXCEL SKILLS. Selecting Cells: Step 1: Click and drag to select the cells you want.

EXCEL SKILLS. Selecting Cells: Step 1: Click and drag to select the cells you want. Selecting Cells: Step 1: Click and drag to select the cells you want. Naming Cells: Viewlet available Step 2: To select different cells that are not next to each other, hold down as you click and

More information

Package ECctmc. May 1, 2018

Package ECctmc. May 1, 2018 Type Package Package ECctmc May 1, 2018 Title Simulation from Endpoint-Conditioned Continuous Time Markov Chains Version 0.2.5 Date 2018-04-30 URL https://github.com/fintzij/ecctmc BugReports https://github.com/fintzij/ecctmc/issues

More information

Package roar. August 31, 2018

Package roar. August 31, 2018 Type Package Package roar August 31, 2018 Title Identify differential APA usage from RNA-seq alignments Version 1.16.0 Date 2016-03-21 Author Elena Grassi Maintainer Elena Grassi Identify

More information

Package sure. September 19, 2017

Package sure. September 19, 2017 Type Package Package sure September 19, 2017 Title Surrogate Residuals for Ordinal and General Regression Models An implementation of the surrogate approach to residuals and diagnostics for ordinal and

More information

Package arphit. March 28, 2019

Package arphit. March 28, 2019 Type Package Title RBA-style R Plots Version 0.3.1 Author Angus Moore Package arphit March 28, 2019 Maintainer Angus Moore Easily create RBA-style graphs

More information

Package omu. August 2, 2018

Package omu. August 2, 2018 Package omu August 2, 2018 Title A Metabolomics Analysis Tool for Intuitive Figures and Convenient Metadata Collection Version 1.0.2 Facilitates the creation of intuitive figures to describe metabolomics

More information

Package ICSShiny. April 1, 2018

Package ICSShiny. April 1, 2018 Package ICSShiny April 1, 2018 Type Package Title ICS via a Shiny Application Version 0.5 Date 2018-04-01 Author Aurore Archimbaud, Joris May, Klaus Nordhausen, Anne Ruiz-Gazen Maintainer Klaus Nordhausen

More information

Desktop Studio: Charts

Desktop Studio: Charts Desktop Studio: Charts Intellicus Enterprise Reporting and BI Platform Intellicus Technologies info@intellicus.com www.intellicus.com Working with Charts i Copyright 2011 Intellicus Technologies This document

More information

Package Linnorm. October 12, 2016

Package Linnorm. October 12, 2016 Type Package Package Linnorm October 12, 2016 Title Linear model and normality based transformation method (Linnorm) Version 1.0.6 Date 2016-08-27 Author Shun Hang Yip , Panwen Wang ,

More information

Package table1. July 19, 2018

Package table1. July 19, 2018 Type Package Version 1.1 Date 2018-07-18 Title Tables of Descriptive Statistics in HTML Package table1 July 19, 2018 Create HTML tables of descriptive statistics, as one would epect to see as the first

More information

User Manual MS Energy Services

User Manual MS Energy Services User Manual MS Energy Services Table of content Access 4 Log In 4 Home Page 5 Add pre-visualisations 6 Pre-visualisation with variables 7 Multiple pre-visualisations 8 Pre-visualisation window 8 Design

More information

Package mgsa. January 13, 2019

Package mgsa. January 13, 2019 Version 1.31.0 Date 2017-04-28 Title Model-based gene set analysis Package mgsa January 13, 2019 Author Sebastian Bauer , Julien Gagneur Maintainer

More information

Package tiler. June 9, 2018

Package tiler. June 9, 2018 Version 0.2.0 Package tiler June 9, 2018 Title Create Geographic and Non-Geographic Map Tiles Creates geographic map tiles from geospatial map files or nongeographic map tiles from simple image files.

More information

Package lvplot. August 29, 2016

Package lvplot. August 29, 2016 Version 0.2.0 Title Letter Value 'Boxplots' Package lvplot August 29, 2016 Implements the letter value 'boxplot' which extends the standard 'boxplot' to deal with both larger and smaller number of data

More information

Package jstree. October 24, 2017

Package jstree. October 24, 2017 Package jstree October 24, 2017 Title Create Interactive Trees with the 'jquery' 'jstree' Plugin Version 1.0.1 Date 2017-10-23 Maintainer Jonathan Sidi Create and customize interactive

More information

Package infer. July 11, Type Package Title Tidy Statistical Inference Version 0.3.0

Package infer. July 11, Type Package Title Tidy Statistical Inference Version 0.3.0 Type Package Title Tidy Statistical Inference Version 0.3.0 Package infer July 11, 2018 The objective of this package is to perform inference using an epressive statistical grammar that coheres with the

More information

Package ggsubplot. February 15, 2013

Package ggsubplot. February 15, 2013 Package ggsubplot February 15, 2013 Maintainer Garrett Grolemund License GPL Title Explore complex data by embedding subplots within plots. LazyData true Type Package Author Garrett

More information

Statistical analysis of RNA-Seq data

Statistical analysis of RNA-Seq data Practical Statistical analysis of RNA-Seq data (solutions) Ignacio González Plateforme Bioinformatique INRA Toulouse Plateforme Biostatistique IMT Université Toulouse III Toulouse, 20/21 novembre 2014

More information

Package pcaexplorer. October 8, 2018

Package pcaexplorer. October 8, 2018 Type Package Package pcaexplorer October 8, 2018 Title Interactive Visualization of RNA-seq Data Using a Principal Components Approach Version 2.6.0 Date 2018-04-04 Maintainer Federico Marini

More information

Package lol. R topics documented: December 13, Type Package Title Lots Of Lasso Version Date Author Yinyin Yuan

Package lol. R topics documented: December 13, Type Package Title Lots Of Lasso Version Date Author Yinyin Yuan Type Package Title Lots Of Lasso Version 1.30.0 Date 2011-04-02 Author Package lol December 13, 2018 Maintainer Various optimization methods for Lasso inference with matri warpper

More information

Error-Bar Charts from Summary Data

Error-Bar Charts from Summary Data Chapter 156 Error-Bar Charts from Summary Data Introduction Error-Bar Charts graphically display tables of means (or medians) and variability. Following are examples of the types of charts produced by

More information

NEW FEATURES IN gint VERSION 8

NEW FEATURES IN gint VERSION 8 NEW FEATURES IN gint VERSION 8 gint Version 8 has over 100 new features in the following areas: Data Design Caption value changes object selector display If at least one record has a value in the Caption,

More information

Package fastqcr. April 11, 2017

Package fastqcr. April 11, 2017 Type Package Title Quality Control of Sequencing Data Version 0.1.0 Date 2017-04-12 Package fastqcr April 11, 2017 'FASTQC' is the most widely used tool for evaluating the quality of high throughput sequencing

More information

Package phantasus. March 8, 2019

Package phantasus. March 8, 2019 Package phantasus March 8, 2019 Title Visual and interactive gene exprsion analysis Version 1.2.1 Phantasus is a web-application for visual and interactive gene exprsion analysis. Phantasus is based on

More information

Package pcapa. September 16, 2016

Package pcapa. September 16, 2016 Package pcapa September 16, 2016 Title Parallel Analysis for Ordinal and Numeric Data using Polychoric and Pearson Correlations with S3 Classes Version 2.0.2 Date 2016-09-14 Author Carlos A. Arias

More information

Package varistran. July 25, 2016

Package varistran. July 25, 2016 Package varistran July 25, 2016 Title Variance Stabilizing Transformations appropriate for RNA-Seq expression data Transform RNA-Seq count data so that variance due to biological noise plus its count-based

More information

Package ggextra. April 4, 2018

Package ggextra. April 4, 2018 Package ggextra April 4, 2018 Title Add Marginal Histograms to 'ggplot2', and More 'ggplot2' Enhancements Version 0.8 Collection of functions and layers to enhance 'ggplot2'. The flagship function is 'ggmarginal()',

More information

Package skynet. December 12, 2018

Package skynet. December 12, 2018 Type Package Version 1.3.0 Title Generates Networks from BTS Data Package skynet December 12, 2018 Maintainer Filipe Teieira URL https://github.com/filipeamteieira/skynet

More information

Package loomr. April 23, 2018

Package loomr. April 23, 2018 Type Package Title An R interface for loom files Version 0.2.0 Date 2018-23-18 Package loomr April 23, 2018 Description An interface for the single-cell RNAseq-oriented loom format. Loom files are an HDF5-

More information

Package orloca. April 21, Type Package Depends methods, png, ucminf Suggests grdevices, graphics, knitr VignetteBuilder knitr

Package orloca. April 21, Type Package Depends methods, png, ucminf Suggests grdevices, graphics, knitr VignetteBuilder knitr Type Package Depends methods, png, ucminf Suggests grdevices, graphics, knitr VignetteBuilder knitr Package orloca April 21, 2018 Title Operations Research LOCational Analysis Models Version 4.5 Date 2018-04-23

More information

Package SNPediaR. April 9, 2019

Package SNPediaR. April 9, 2019 Title Query data from SNPedia Version 1.8.0 Date 2015-09-26 Package SNPediaR April 9, 2019 Description SNPediaR provides some tools for downloading and parsing data from the SNPedia web site .

More information

Package arc. April 18, 2018

Package arc. April 18, 2018 Title Association Rule Classification Version 1.2 Date 2018-04-13 Author Tomas Kliegr [aut, cre] Maintainer Tomas Kliegr Package arc April 18, 2018 Implements the Classification-based

More information

Package DupChecker. April 11, 2018

Package DupChecker. April 11, 2018 Type Package Package DupChecker April 11, 2018 Title a package for checking high-throughput genomic data redundancy in meta-analysis Version 1.16.0 Date 2014-10-07 Author Quanhu Sheng, Yu Shyr, Xi Chen

More information