Package Glimma. June 29, 2018

Size: px
Start display at page:

Download "Package Glimma. June 29, 2018"

Transcription

1 Type Package Title Interactive HTML graphics Version Date Package Glimma June 29, 2018 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, GeneEpression, Microarray, ReportWriting, RNASeq, Sequencing, Visualization Depends R (>= 3.4.0) Imports edger, grdevices, jsonlite, methods, stats, S4Vectors, utils Suggests BiocStyle, IRanges, GenomicRanges, SummarizedEperiment, DESeq2, limma, testthat, knitr, rmarkdown, pryr License GPL-3 file LICENSE URL BugReports RoygenNote NeedsCompilation no LazyData true VignetteBuilder knitr git_url git_branch RELEASE_3_7 git_last_commit 7696aca git_last_commit_date Date/Publication Author Shian Su [aut, cre], Matthew Ritchie [aut], Charity Law [aut], Stuart Lee [ctb] Maintainer Shian Su <su.s@wehi.edu.au> 1

2 2 arraydata R topics documented: arraydata as.hecol glbar glbar.default glimma gllink glmdplot glmdplot.default glmdplot.deseqdataset glmdplot.deseqresults glmdplot.dgeeact glmdplot.dgelrt glmdplot.marraylm glmdrmd glmdsplot glmdsplot.default glmdsplot.deseqdataset glmdsplot.dgelist glscatter glscatter.default gltable gltablink glxyplot is.he lymphomarnaseq makejson makejson.data.frame makejson.jschart Inde 29 arraydata Eample microarray for the study of Ezh2. Eample microarray for the study of Ezh2. Bhupinder Pal, Toula Bouras, Wei Shi, Francois Vaillant, Julie M. Sheridan, Naiyang Fu, Kelsey Breslin, Kun Jiang, Matthew E. Ritchie, Matthew Young, Geoffrey J. Lindeman, Gordon K. Smyth, Jane E. Visvader References

3 as.hecol 3 as.hecol Numeric to he colour converter Convert numbers and R colour strings 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")) 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

4 4 glbar.default 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,...) 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.

5 glimma 5 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)... 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))

6 6 glmdplot 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. 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(,...)

7 glmdplot 7 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. Shian Su See Also 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 <- [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")

8 8 glmdplot.default 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 = NULL, samples = NULL, status = rep(0, nrow()), transform = FALSE, main = "", lab = val, ylab = yval, side.main = "GeneID", side.lab = "Group", side.ylab = "Epression", side.log = FALSE, side.gridstep = ifelse(!transform side.log, FALSE, 0.5), jitter = 30, display.columns = side.main, cols = c("#00bfff", "#858585", "#ff3030"), sample.cols = rep("#1f77b4", ncol(counts)), path = getwd(), folder = "glimma-plots", html = "MD-Plot", launch = TRUE,...) val yval counts anno groups samples status transform main lab ylab side.main side.lab side.ylab side.log side.gridstep 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 of epression values, with samples in columns. 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 should be log-cpm transformed. the title for the left plot. the label on the ais for the left plot. the label on the y ais for the left plot. the column containing mains for right plot. label for ais on right plot. label for y ais on right plot. TRUE to plot epression on the right plot on log scale. intervals along which to place grid lines on y ais. Currently only available for linear scale. jitter the amount of jitter to apply to the samples in the epressions plot. display.columns character vector containing names of columns to display in mouseover tooltips and table.

9 glmdplot.deseqdataset 9 cols vector of strings denoting colours corresponding to control status -1, 0 and 1. (may be R named colours or He values) sample.cols path folder html launch vector of strings denoting colours for each sample point on the epression 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, 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.deseqdataset Glimma MD Plot Draw an interactive MD plot from a DESeqDataSet object ## S3 method for class 'DESeqDataSet' glmdplot(, counts = NULL, anno, groups, samples = NULL, status = rep(0, nrow()), transform = FALSE, main = "", lab = "Mean Epression", ylab = "log-fold-change", side.lab = "Group", side.ylab = "logmean", side.log = FALSE, side.gridstep = ifelse(!transform side.log, FALSE, 0.5), jitter = 30, side.main = "GeneID", display.columns = NULL, cols = c("#00bfff", "#858585", "#ff3030"), sample.cols = rep("#1f77b4", ncol()), path = getwd(), folder = "glimma-plots", html = "MD-Plot", launch = TRUE,...) counts anno groups samples the DESeqDataSet object. the matri of epression values, with samples in columns. the data.frame containing gene annotations. the factor containing eperimental groups of the samples. the names of the samples.

10 10 glmdplot.deseqdataset status transform main lab ylab side.lab side.ylab side.log side.gridstep jitter 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 should be log-cpm transformed. the title for the left plot. label for ais on left plot. label for y ais on left plot. label for ais on right plot. label for y ais on right plot. TRUE to plot epression on the right plot on log scale. intervals along which to place grid lines on y ais. Currently only available for linear scale. the amount of jitter to apply to the samples in the epressions plot. side.main the column containing mains for right plot. 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 path folder html launch vector of strings denoting colours for each sample point on the epression 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, 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

11 glmdplot.deseqresults 11 glmdplot.deseqresults Glimma MD Plot Draw an interactive MD plot from a DESeqResults object ## S3 method for class 'DESeqResults' glmdplot(, counts = NULL, anno, groups, samples = NULL, status = rep(0, nrow()), transform = FALSE, main = "", lab = "Mean Epression", ylab = "log-fold-change", side.lab = "Group", side.ylab = "Epression", side.log = FALSE, side.gridstep = ifelse(!transform side.log, FALSE, 0.5), jitter = 30, side.main = "GeneID", display.columns = NULL, cols = c("#00bfff", "#858585", "#ff3030"), sample.cols = rep("#1f77b4", ncol(counts)), path = getwd(), folder = "glimma-plots", html = "MD-Plot", launch = TRUE,...) counts anno groups samples status transform main lab ylab side.lab side.ylab side.log side.gridstep jitter the DESeqResults object. the matri of epression values, with samples in columns. 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 should be log-cpm transformed. the title for the left plot. label for ais on left plot. label for y ais on left plot. label for ais on right plot. label for y ais on right plot. TRUE to plot epression on the right plot on log scale. intervals along which to place grid lines on y ais. Currently only available for linear scale. the amount of jitter to apply to the samples in the epressions plot. side.main the column containing mains for right plot. 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)

12 12 glmdplot.dgeeact sample.cols path folder html launch vector of strings denoting colours for each sample point on the epression 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, 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 ## S3 method for class 'DGEEact' glmdplot(, counts = NULL, anno = NULL, groups = NULL, samples = NULL, status = rep(0, nrow()), transform = FALSE, main = "", lab = "Average log CPM", ylab = "log-fold-change", side.lab = "Group", side.ylab = "Epression", side.log = FALSE, side.gridstep = ifelse(!transform side.log, FALSE, 0.5), p.adj.method = "BH", jitter = 30, side.main = "GeneID", display.columns = NULL, cols = c("#00bfff", "#858585", "#ff3030"), sample.cols = rep("#1f77b4", ncol(counts)), path = getwd(), folder = "glimma-plots", html = "MD-Plot", launch = TRUE,...) counts anno groups samples status the DGEEact object. the matri of epression values, with samples in columns. 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.

13 glmdplot.dgeeact 13 transform main lab ylab side.lab side.ylab side.log side.gridstep p.adj.method jitter TRUE if counts should be log-cpm transformed. the title for the left plot. label for ais on left plot. label for y ais on left plot. label for ais on right plot. label for y ais on right plot. TRUE to plot epression on the right 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. See p.adjust for available methods. (defaults to "BH") the amount of jitter to apply to the samples in the epressions plot. side.main the column containing mains for right plot. 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 path folder html launch vector of strings denoting colours for each sample point on the epression 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, 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

14 14 glmdplot.dgelrt 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 = NULL, samples = NULL, status = rep(0, nrow()), transform = FALSE, main = "", lab = "Average log CPM", ylab = "log-fold-change", side.lab = "Group", side.ylab = "Epression", side.log = FALSE, side.gridstep = ifelse(!transform side.log, FALSE, 0.5), p.adj.method = "BH", jitter = 30, side.main = "GeneID", display.columns = NULL, cols = c("#00bfff", "#858585", "#ff3030"), sample.cols = rep("#1f77b4", ncol(counts)), path = getwd(), folder = "glimma-plots", html = "MD-Plot", launch = TRUE,...) counts anno groups samples status transform main lab ylab side.lab side.ylab side.log side.gridstep p.adj.method jitter the DGELRT object. the matri of epression values, with samples in columns. 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 should be log-cpm transformed. the title for the left plot. label for ais on left plot. label for y ais on left plot. label for ais on right plot. label for y ais on right plot. TRUE to plot epression on the right 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. See p.adjust for available methods. (defaults to "BH") the amount of jitter to apply to the samples in the epressions plot. side.main the column containing mains for right plot. display.columns character vector containing names of columns to display in mouseover tooltips and table.

15 glmdplot.marraylm 15 cols vector of strings denoting colours corresponding to control status -1, 0 and 1. (may be R named colours or He values) sample.cols path folder html launch vector of strings denoting colours for each sample point on the epression 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, 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 = NULL, samples = NULL, status = rep(0, nrow()), transform = FALSE, main = "", lab = "Average log CPM", ylab = "log-fold-change", side.main = "GeneID", side.lab = "Group", side.ylab = "Epression", side.log = FALSE, side.gridstep = ifelse(!transform side.log, FALSE, 0.5), coef = ncol($coefficients), p.adj.method = "BH", jitter = 30, display.columns = NULL, cols = c("#00bfff", "#858585", "#ff3030"), sample.cols = rep("#1f77b4", ncol(counts)), path = getwd(), folder = "glimma-plots", html = "MD-Plot", launch = TRUE,...) counts anno groups samples the MArrayLM object. the matri of epression values, with samples in columns. the data.frame containing gene annotations. the factor containing eperimental groups of the samples. the names of the samples.

16 16 glmdplot.marraylm status transform main lab ylab side.main side.lab side.ylab side.log side.gridstep coef p.adj.method 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 should be log-cpm transformed. the title for the left plot. label for ais on left plot. label for y ais on left plot. the column containing mains for right plot. label for ais on right plot. label for y ais on right plot. TRUE to plot epression on the right 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. See p.adjust for available methods. (defaults to "BH") jitter the amount of jitter to apply to the samples in the epressions plot. 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 path folder html launch vector of strings denoting colours for each sample point on the epression 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, 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 Eamples library(limma) library(edger)

17 glmdrmd 17 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") glmdrmd glmdplot Rmarkdown link and instructions When run inside of a tet-block of Rmarkdown document using r... this produces a link and instructions about the usage of the interactive plots. glmdrmd(html = "MD-Plot") html name of the HTML page containing plots from glmdplot. None See Also glmdplot Eamples glmdrmd()

18 18 glmdsplot glmdsplot Glimma MDS Plot Glimma MDS Plot Draw an interactive MD plot from a DGEList object with distances calculated from most variable genes. glmdsplot(,...) the matri containing the gene epressions.... 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 See Also glmdsplot.default, glmdsplot.dgelist Eamples data(lymphomarnaseq) genotype <- relevel(lymphomarnaseq$samples$group, "Smchd1-null") glmdsplot(lymphomarnaseq, labels=1:7, groups=genotype)

19 glmdsplot.default 19 glmdsplot.default Glimma MDS Plot Glimma MDS Plot Draw an interactive MD plot from a DGEList object with distances calculated from most variable genes. ## Default S3 method: glmdsplot(, top = 500, labels = seq_cols(), groups = rep(1, ncol()), gene.selection = c("pairwise", "common"), 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 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. 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

20 20 glmdsplot.deseqdataset glmdsplot.deseqdataset Glimma MDS Plot Glimma MDS Plot Draw an interactive MD plot from a DGEList object with distances calculated from most variable genes. ## S3 method for class 'DESeqDataSet' glmdsplot(, top = 500, labels = NULL, groups = NULL, gene.selection = c("pairwise", "common"), prior.count = 0.25, main = "MDS Plot", path = getwd(), folder = "glimma-plots", html = "MDS-Plot", launch = TRUE,...) top labels groups the DESeqDataSet 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. prior.count main path folder html launch average count to be added to each observation to avoid taking log of zero. Used only if log=true. 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. 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

21 glmdsplot.dgelist 21 glmdsplot.dgelist Glimma MDS Plot 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 = NULL, groups = rep(1, ncol()), gene.selection = c("pairwise", "common"), prior.count = 0.25, 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. prior.count main path folder html launch average count to be added to each observation to avoid taking log of zero. Used only if log=true. 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. 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

22 22 glscatter.default 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)) 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,...)

23 glscatter.default 23 val yval idval point.size.jitter y.jitter ndigits signif log grid ygrid step ystep lab ylab main height width colval annot annot.lab flag info hide disable the data.frame containing data to plot. the column name for the -ais values. the column name for the y-ais values. the column name for unique identifiers. the size of the data points. the amount of jittering to add to values along the ais. the amount of jittering to add to values along the y ais. the number of digits after the decimal to round to in the tooltip (overrides signif). the number of significant figures to display in the tooltip. 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. TRUE if grid lines should be placed along ais. TRUE if grid lines should be placed y ais. the interval at which to set grid lines along the ais. the interval at which to set grid lines along the y ais. the label on the -ais. the label on the y-ais. the title for the plot. the height of the plot (in piels). the width of the plot (in piels). the colours for each data point. the columns to display in the tooltip. alternative labels for the values displayed in the tooltip. the special flag to indicate special plot. additional information for plotting. TRUE to hide the plot when page starts. the events to disable, options are "click", "hover", "zoom".... additional arguments. 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))

24 24 gltablink 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") 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.

25 glxyplot 25 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, lab = "", ylab = "y", side.main = "GeneID", side.lab = "Group", side.ylab = "Epression", sample.cols = rep("#1f77b4", length(groups)), cols = c("#00bfff", "#858585", "#ff3030"), 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 column order should correspond to the order of the and y vectors. 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 anno the data.frame containing gene annotations. display.columns character vector containing names of columns to display in mouseover tooltips and table. lab ylab side.main side.lab side.ylab sample.cols the label on the ais for the left plot. the label on the y ais for the left plot. the column containing mains for right 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. 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)

26 26 is.he 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", side.main="plantid") is.he Hecode colours Check if string(s) are valid he colour representation is.he() the colour value(s) to check. Logical vector indicating if strings(s) are valid he representations

27 lymphomarnaseq 27 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 JSON converter for R objects Function to generate json strings from makejson(,...) the object to be converted into JSON... additional arguments a stringified JSON object.

28 28 makejson.jschart 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, dataframe = c("rows", "columns")) df the data.frame to be converted into JSON convert.logical whether to convert logicals into strings "TRUE" and "FALSE" dataframe how to encode data.frame objects: must be one of rows, columns 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. makejson.jschart JSON converter for chart objects Function to make json object from a chart, ignoring the json property ## S3 method for class 'jschart' makejson(chart) chart the chart object to be converted into JSON a stringified JSON object containing the chart data.

29 Inde Topic RNAseq lymphomarnaseq, 27 Topic microarray arraydata, 2 arraydata, 2 as.hecol, 3 glbar, 3 glbar.default, 4, 4 glimma, 5 gllink, 6 glmdplot, 6, 17 glmdplot.default, 7, 8 glmdplot.deseqdataset, 7, 9 glmdplot.deseqresults, 11 glmdplot.dgeeact, 7, 12 glmdplot.dgelrt, 7, 14 glmdplot.marraylm, 7, 15 glmdrmd, 17 glmdsplot, 18 glmdsplot.default, 18, 19 glmdsplot.deseqdataset, 20 glmdsplot.dgelist, 18, 21 glscatter, 22 glscatter.default, 22 gltable, 24 gltablink, 24 glxyplot, 25 is.he, 26 lymphomarnaseq, 27 makejson, 27 makejson.data.frame, 28 makejson.jschart, 28 p.adjust, 13, 14, 16 29

Package Glimma. April 14, 2017

Package Glimma. April 14, 2017 Type Package Title Interactive HTML graphics Version 1.2.1 Date 2016-02-29 Author Shian Su, Matt Ritchie, Charity Law Maintainer Shian Su Package Glimma April 14, 2017 This package generates

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 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 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 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 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 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 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 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 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 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

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 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 fastdummies. January 8, 2018

Package fastdummies. January 8, 2018 Type Package Package fastdummies January 8, 2018 Title Fast Creation of Dummy (Binary) Columns and Rows from Categorical Variables Version 1.0.0 Description Creates dummy columns from columns that have

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 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 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 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 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 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 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 labelvector. July 28, 2018

Package labelvector. July 28, 2018 Title Label Attributes for Atomic Vectors Version 0.1.0 Package labelvector July 28, 2018 Labels are a common construct in statistical software providing a human readable description of a variable. While

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 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 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 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 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 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 cattonum. R topics documented: May 2, Type Package Version Title Encode Categorical Features

Package cattonum. R topics documented: May 2, Type Package Version Title Encode Categorical Features Type Package Version 0.0.2 Title Encode Categorical Features Package cattonum May 2, 2018 Functions for dummy encoding, frequency encoding, label encoding, leave-one-out encoding, mean encoding, median

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 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 seqcat. March 25, 2019

Package seqcat. March 25, 2019 Package seqcat March 25, 2019 Title High Throughput Sequencing Cell Authentication Toolkit Version 1.4.1 The seqcat package uses variant calling data (in the form of VCF files) from high throughput sequencing

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 mimager. March 7, 2019

Package mimager. March 7, 2019 Package mimager March 7, 2019 Version 1.6.0 Type Package Title mimager: The Microarray Imager Easily visualize and inspect microarrays for spatial artifacts. License MIT + file LICENSE LazyData TRUE Depends

More information

Package MEAL. August 16, 2018

Package MEAL. August 16, 2018 Title Perform methylation analysis Version 1.11.6 Package MEAL August 16, 2018 Package to integrate methylation and expression data. It can also perform methylation or expression analysis alone. Several

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 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 stapler. November 27, 2017

Package stapler. November 27, 2017 Version 0.6.3 Package stapler November 27, 2017 Title Simultaneous Truth and Performance Level Estimation An implementation of Simultaneous Truth and Performance Level Estimation (STAPLE) .

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 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 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 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 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 gpart. November 19, 2018

Package gpart. November 19, 2018 Package gpart November 19, 2018 Title Human genome partitioning of dense sequencing data by identifying haplotype blocks Version 1.0.0 Depends R (>= 3.5.0), grid, Homo.sapiens, TxDb.Hsapiens.UCSC.hg38.knownGene,

More information

Package docxtools. July 6, 2018

Package docxtools. July 6, 2018 Title Tools for R Markdown to Docx Documents Version 0.2.0 Language en-us Package docxtools July 6, 2018 A set of helper functions for using R Markdown to create documents in docx format, especially documents

More information

Package scmap. March 29, 2019

Package scmap. March 29, 2019 Type Package Package scmap March 29, 2019 Title A tool for unsupervised projection of single cell RNA-seq data Version 1.4.1 Author Vladimir Kiselev Maintainer Vladimir Kiselev

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 omicplotr. March 15, 2019

Package omicplotr. March 15, 2019 Package omicplotr March 15, 2019 Title Visual Exploration of Omic Datasets Using a Shiny App Version 1.2.1 Date 2018-05-23 biocviews ImmunoOncology, Software, DifferentialExpression, GeneExpression, GUI,

More information

Package multihiccompare

Package multihiccompare Package multihiccompare September 23, 2018 Title Normalize and detect differences between Hi-C datasets when replicates of each experimental condition are available Version 0.99.44 multihiccompare provides

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 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 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 catenary. May 4, 2018

Package catenary. May 4, 2018 Type Package Title Fits a Catenary to Given Points Version 1.1.2 Date 2018-05-04 Package catenary May 4, 2018 Gives methods to create a catenary object and then plot it and get properties of it. Can construct

More information

Package lumberjack. R topics documented: July 20, 2018

Package lumberjack. R topics documented: July 20, 2018 Package lumberjack July 20, 2018 Maintainer Mark van der Loo License GPL-3 Title Track Changes in Data LazyData no Type Package LazyLoad yes A function composition ('pipe') operator

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 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 ggimage. R topics documented: December 5, Title Use Image in 'ggplot2' Version 0.1.0

Package ggimage. R topics documented: December 5, Title Use Image in 'ggplot2' Version 0.1.0 Title Use Image in 'ggplot2' Version 0.1.0 Package ggimage December 5, 2017 Supports image files and graphic objects to be visualized in 'ggplot2' graphic system. Depends R (>= 3.3.0), ggplot2 Imports

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 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 BubbleTree. December 28, 2018

Package BubbleTree. December 28, 2018 Type Package Package BubbleTree December 28, 2018 Title BubbleTree: an intuitive visualization to elucidate tumoral aneuploidy and clonality in somatic mosaicism using next generation sequencing data Version

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 MIRA. October 16, 2018

Package MIRA. October 16, 2018 Version 1.2.0 Date 2018-04-17 Package MIRA October 16, 2018 Title Methylation-Based Inference of Regulatory Activity MIRA measures the degree of ``dip'' in methylation level surrounding a regulatory site

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 JunctionSeq. November 1, 2018

Package JunctionSeq. November 1, 2018 Package JunctionSeq November 1, 2018 Version 1.12.0 Title JunctionSeq: A Utility for Detection of Differential Exon and Splice-Junction Usage in RNA-Seq data Depends R (>= 3.2.2), methods, SummarizedExperiment

More information

Package DRIMSeq. December 19, 2018

Package DRIMSeq. December 19, 2018 Type Package Package DRIMSeq December 19, 2018 Title Differential transcript usage and tuqtl analyses with Dirichlet-multinomial model in RNA-seq Version 1.10.0 Date 2017-05-24 Description The package

More information

Package TMixClust. July 13, 2018

Package TMixClust. July 13, 2018 Package TMixClust July 13, 2018 Type Package Title Time Series Clustering of Gene Expression with Gaussian Mixed-Effects Models and Smoothing Splines Version 1.2.0 Year 2017 Date 2017-06-04 Author Monica

More information

Package ggrepel. September 30, 2017

Package ggrepel. September 30, 2017 Version 0.7.0 Package ggrepel September 30, 2017 Title Repulsive Text and Label Geoms for 'ggplot2' Description Provides text and label geoms for 'ggplot2' that help to avoid overlapping text labels. Labels

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 ggimage. R topics documented: November 1, Title Use Image in 'ggplot2' Version 0.0.7

Package ggimage. R topics documented: November 1, Title Use Image in 'ggplot2' Version 0.0.7 Title Use Image in 'ggplot2' Version 0.0.7 Package ggimage November 1, 2017 Supports image files and graphic objects to be visualized in 'ggplot2' graphic system. Depends R (>= 3.3.0), ggplot2 Imports

More information

Package DMCHMM. January 19, 2019

Package DMCHMM. January 19, 2019 Package DMCHMM January 19, 2019 Type Package Title Differentially Methylated CpG using Hidden Markov Model Version 1.4.0 Author Farhad Shokoohi Maintainer A pipeline for identifying differentially methylated

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 clustree. July 10, 2018

Package clustree. July 10, 2018 Type Package Package clustree July 10, 2018 Title Visualise Clusterings at Different Resolutions Version 0.2.2 Date 2018-07-10 Maintainer Luke Zappia Deciding what resolution

More information

Package sigqc. June 13, 2018

Package sigqc. June 13, 2018 Title Quality Control Metrics for Gene Signatures Version 0.1.20 Package sigqc June 13, 2018 Description Provides gene signature quality control metrics in publication ready plots. Namely, enables the

More information

Package pcaexplorer. December 19, 2018

Package pcaexplorer. December 19, 2018 Type Package Package pcaexplorer December 19, 2018 Title Interactive Visualization of RNA-seq Data Using a Principal Components Approach Version 2.9.3 Date 2018-11-21 Maintainer Federico Marini

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 BgeeDB. January 5, 2019

Package BgeeDB. January 5, 2019 Type Package Package BgeeDB January 5, 2019 Title Annotation and gene expression data retrieval from Bgee database Version 2.8.0 Date 2018-06-12 Author Andrea Komljenovic [aut, cre], Julien Roux [aut,

More information

Package preprosim. July 26, 2016

Package preprosim. July 26, 2016 Package preprosim July 26, 2016 Type Package Title Lightweight Data Quality Simulation for Classification Version 0.2.0 Date 2016-07-26 Data quality simulation can be used to check the robustness of data

More information

Package sparsenetgls

Package sparsenetgls Type Package Package sparsenetgls March 18, 2019 Title Using Gaussian graphical structue learning estimation in generalized least squared regression for multivariate normal regression Version 1.0.1 Maintainer

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 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 LOLA. December 24, 2018

Package LOLA. December 24, 2018 Package LOLA December 24, 2018 Version 1.13.0 Date 2015-06-26 Title Locus overlap analysis for enrichment of genomic ranges Provides functions for testing overlap of sets of genomic regions with public

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 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

Package validara. October 19, 2017

Package validara. October 19, 2017 Type Package Title Validate Brazilian Administrative Registers Version 0.1.1 Package validara October 19, 2017 Maintainer Gustavo Coelho Contains functions to validate administrative

More information

Package profvis. R topics documented:

Package profvis. R topics documented: Package profvis January 14, 2017 Title Interactive Visualizations for Profiling R Code Version 0.3.3 Interactive visualizations for profiling R code. Depends R (>= 3.0) Imports htmlwidgets (>= 0.3.2),

More information

Package gridextra. September 9, 2017

Package gridextra. September 9, 2017 License GPL (>= 2) Package gridextra September 9, 2017 Title Miscellaneous Functions for ``Grid'' Graphics Type Package Provides a number of user-level functions to work with ``grid'' graphics, notably

More information

Package TnT. November 22, 2017

Package TnT. November 22, 2017 Package TnT November 22, 2017 Title Interactive Visualization for Genomic Features Version 1.0.1 A R interface to the TnT javascript library (https://github.com/ tntvis) to provide interactive and flexible

More information

Package sigmanet. April 23, 2018

Package sigmanet. April 23, 2018 Title Render Graphs Using 'Sigma.js' Version 1.1.0 Maintainer Ian Kloo URL https://github.com/iankloo/manet Package manet April 23, 2018 BugReports https://github.com/iankloo/manet/issues

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 mfa. R topics documented: July 11, 2018

Package mfa. R topics documented: July 11, 2018 Package mfa July 11, 2018 Title Bayesian hierarchical mixture of factor analyzers for modelling genomic bifurcations Version 1.2.0 MFA models genomic bifurcations using a Bayesian hierarchical mixture

More information

Package incidence. August 24, Type Package

Package incidence. August 24, Type Package Type Package Package incidence August 24, 2018 Title Compute, Handle, Plot and Model Incidence of Dated Events Version 1.4.1 Provides functions and classes to compute, handle and visualise incidence from

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 bacon. October 31, 2018

Package bacon. October 31, 2018 Type Package Package October 31, 2018 Title Controlling bias and inflation in association studies using the empirical null distribution Version 1.10.0 Author Maarten van Iterson [aut, cre], Erik van Zwet

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 ezsummary. August 29, 2016

Package ezsummary. August 29, 2016 Type Package Title Generate Data Summary in a Tidy Format Version 0.2.1 Package ezsummary August 29, 2016 Functions that simplify the process of generating print-ready data summary using 'dplyr' syntax.

More information

Package condusco. November 8, 2017

Package condusco. November 8, 2017 Type Package Package condusco November 8, 2017 Title Query-Driven Pipeline Execution and Query Templates Version 0.1.0 Author Roland Stevenson Maintainer Roland Stevenson Description

More information

Package ggseas. June 12, 2018

Package ggseas. June 12, 2018 Package ggseas June 12, 2018 Title 'stats' for Seasonal Adjustment on the Fly with 'ggplot2' Version 0.5.4 Maintainer Peter Ellis Provides 'ggplot2' 'stats' that estimate

More information

Package FitHiC. October 16, 2018

Package FitHiC. October 16, 2018 Type Package Package FitHiC October 16, 2018 Title Confidence estimation for intra-chromosomal contact maps Version 1.6.0 Date 2017-04-12 Description Fit-Hi-C is a tool for assigning statistical confidence

More information

Package ERSSA. November 4, 2018

Package ERSSA. November 4, 2018 Type Package Title Empirical RNA-seq Sample Size Analysis Version 1.0.0 Date 2018-10-09 Author Zixuan Shao [aut, cre] Package ERSSA November 4, 2018 Maintainer Zixuan Shao The

More information

Package limmagui. July 22, 2018

Package limmagui. July 22, 2018 Package limmagui July 22, 2018 Version 1.56.1 Date 2018-05-03 Title GUI for limma Package With Two Color Microarrays Author James Wettenhall [aut], Gordon Smyth [aut], Keith Satterley [ctb] Maintainer

More information