Package clusterprofiler

Size: px
Start display at page:

Download "Package clusterprofiler"

Transcription

1 Type Package Package clusterprofiler January 22, 2018 Title statistical analysis and visualization of functional profiles for genes and gene clusters Version Maintainer This package implements methods to analyze and visualize functional profiles (GO and KEGG) of gene and gene clusters. Depends R (>= 3.3.1), DOSE (>= 3.3.2) Imports AnnotationDbi, ggplot2, GO.db, GOSemSim (>= 2.0.0), magrittr, methods, plyr, qvalue, rvcheck, stats, stats4, tidyr, utils Suggests AnnotationHub, GSEABase, KEGG.db, knitr, org.hs.eg.db, prettydoc, pathview, ReactomePA, testthat, topgo VignetteBuilder knitr ByteCompile true License Artistic-2.0 URL BugReports biocviews Annotation, Clustering, GeneSetEnrichment, GO, KEGG, MultipleComparison, Pathways, Reactome, Visualization RoxygenNote NeedsCompilation no Author [aut, cre, cph] (< Li-Gen Wang [ctb], Giovanni Dall'Olio [ctb] (formula interface of comparecluster) R topics documented: clusterprofiler-package bitr bitr_kegg browsekegg buildgomap comparecluster

2 2 clusterprofiler-package compareclusterresult-class DataSet dotplot,compareclusterresult-method download_kegg dropgo enrichdavid enricher enrichgo enrichkegg enrichmkegg fortify.compareclusterresult getgolevel Gff2GeneTable go2ont go2term gofilter groupgo groupgoresult-class GSEA gsego gsekegg gsemkegg idtype KEGG_path2extid ko2name merge_result plot plotgograph plotting.clusterprofile read.gmt search_kegg_organism simplify viewkegg Index 28 clusterprofiler-package statistical analysis and visualization of functional profiles for genes and gene clusters The package implements methods to analyze and visualize functional profiles of gene and gene clusters. statistical analysis and visualization of functional profiles for genes and gene clusters The package implements methods to analyze and visualize functional profiles of gene and gene clusters.

3 bitr 3 bitr bitr Biological Id TRanslator bitr(geneid, fromtype, totype, OrgDb, drop = TRUE) geneid fromtype totype OrgDb drop input gene id input id type output id type annotation db drop NA or not data.frame bitr_kegg bitr_kegg convert biological ID using KEGG API bitr_kegg(geneid, fromtype, totype, organism, drop = TRUE) geneid fromtype totype organism drop input gene id input id type output id type supported organism, can be search using search_kegg_organism function drop NA or not data.frame

4 4 buildgomap browsekegg browsekegg open KEGG pathway with web browser browsekegg(x, pathid) x pathid an instance of enrichresult or gsearesult pathway ID url buildgomap buildgomap building GO mapping files buildgomap(gomap) gomap data.frame with two columns of GO and gene ID Details provided by a data.frame of GO (column 1) and gene (column 2) direct annotation this function will building gene to GO and GO to gene mapping, with directly and undirectly (ancestor GO term) annotation. data.frame, GO annotation with indirect annotation

5 comparecluster 5 Yu Guangchuang comparecluster Compare gene clusters functional profile Given a list of gene set, this function will compute profiles of each gene cluster. comparecluster(geneclusters, fun = "enrichgo", data = "",...) geneclusters fun data... Other arguments. A clusterprofresult instance. See Also a list of entrez gene id. Alternatively, a formula of type Entrez~group One of "groupgo", "enrichgo", "enrichkegg", "enrichdo" or "enrichpathway". if geneclusters is a formula, the data from which the clusters must be extracted. compareclusterresult-class, groupgo enrichgo Examples ## Not run: data(gcsample) xx <- comparecluster(gcsample, fun="enrichkegg", organism="hsa", pvaluecutoff=0.05) as.data.frame(xx) # plot(xx, type="dot", caption="kegg Enrichment Comparison") ## formula interface mydf <- data.frame(entrez=c('1', '100', '1000', ' ', ' ', ' '), group = c('a', 'A', 'A', 'B', 'B', 'B'), othergroup = c('good', 'good', 'bad', 'bad', 'good', 'bad')) xx.formula <- comparecluster(entrez~group, data=mydf, fun='groupgo', OrgDb='org.Hs.eg.db') as.data.frame(xx.formula)

6 6 DataSet ## formula interface with more than one grouping variable xx.formula.twogroups <- comparecluster(entrez~group+othergroup, data=mydf, fun='groupgo', OrgDb='org.Hs.eg.db') as.data.frame(xx.formula.twogroups) ## End(Not run) compareclusterresult-class Class "compareclusterresult" This class represents the comparison result of gene clusters by GO categories at specific level or GO enrichment analysis. Class "compareclusterresult" This class represents the comparison result of gene clusters by GO categories at specific level or GO enrichment analysis. Slots compareclusterresult cluster comparing result geneclusters a list of genes fun one of groupgo, enrichgo and enrichkegg.call function call See Also groupgoresult enrichresult comparecluster DataSet Datasets gcsample contains a sample of gene clusters. Datasets gcsample contains a sample of gene clusters. Datasets kegg_species contains kegg species information

7 dotplot,compareclusterresult-method 7 dotplot,compareclusterresult-method dotplot dot plot method ## S4 method for signature 'compareclusterresult' dotplot(object, x = ~Cluster, colorby = "p.adjust", showcategory = 5, by = "generatio", split = NULL, includeall = TRUE, font.size = 12, title = "") object x colorby showcategory by split includeall font.size title compareclusterresult object x variable one of pvalue or p.adjust category numbers one of generatio, Percentage or count ONTOLOGY or NULL logical font size figure title download_kegg download_kegg download the latest version of KEGG pathway/module download_kegg(species, keggtype = "KEGG", keytype = "kegg") species keggtype keytype species one of KEGG or MKEGG supported keytype, see bitr_kegg list

8 8 enrichdavid dropgo dropgo drop GO term of specific level or specific terms (mostly too general). dropgo(x, level = NULL, term = NULL) x level term an instance of enrichresult or compareclusterresult GO level GO term modified version of x enrichdavid enrichdavid enrichment analysis by DAVID enrichdavid(gene, idtype = "ENTREZ_GENE_ID", universe, mingssize = 10, maxgssize = 500, annotation = "GOTERM_BP_FAT", pvaluecutoff = 0.05, padjustmethod = "BH", qvaluecutoff = 0.2, species = NA, david.user)

9 enricher 9 gene idtype universe mingssize maxgssize annotation pvaluecutoff padjustmethod qvaluecutoff species david.user input gene id type background genes minimal size of genes annotated for testing maximal size of genes annotated for testing david annotation pvaluecutoff one of "BH" and "bonferroni" qvalutcutoff species david user A enrichresult instance enricher enricher A universal enrichment analyzer enricher(gene, pvaluecutoff = 0.05, padjustmethod = "BH", universe, mingssize = 10, maxgssize = 500, qvaluecutoff = 0.2, TERM2GENE, TERM2NAME = NA) gene pvaluecutoff padjustmethod universe mingssize maxgssize qvaluecutoff TERM2GENE TERM2NAME a vector of gene id pvalue cutoff one of "holm", "hochberg", "hommel", "bonferroni", "BH", "BY", "fdr", "none" background genes minimal size of genes annotated for testing maximal size of genes annotated for testing qvalue cutoff user input annotation of TERM TO GENE mapping, a data.frame of 2 column with term and gene user input of TERM TO NAME mapping, a data.frame of 2 column with term and name

10 10 enrichgo A enrichresult instance enrichgo GO Enrichment Analysis of a gene set. Given a vector of genes, this function will return the enrichment GO categories after FDR control. GO Enrichment Analysis of a gene set. Given a vector of genes, this function will return the enrichment GO categories after FDR control. enrichgo(gene, OrgDb, keytype = "ENTREZID", ont = "MF", pvaluecutoff = 0.05, padjustmethod = "BH", universe, qvaluecutoff = 0.2, mingssize = 10, maxgssize = 500, readable = FALSE, pool = FALSE) gene OrgDb keytype ont pvaluecutoff padjustmethod universe qvaluecutoff mingssize maxgssize readable pool a vector of entrez gene id. OrgDb keytype of input gene One of "MF", "BP", and "CC" subontologies. Cutoff value of pvalue. one of "holm", "hochberg", "hommel", "bonferroni", "BH", "BY", "fdr", "none" background genes qvalue cutoff minimal size of genes annotated by Ontology term for testing. maximal size of genes annotated for testing whether mapping gene ID to gene Name If ont= ALL, whether pool 3 GO sub-ontologies An enrichresult instance. See Also enrichresult-class, comparecluster

11 enrichkegg 11 Examples ## Not run: data(genelist) de <- names(genelist)[1:100] yy <- enrichgo(de, 'org.hs.eg.db', ont="bp", pvaluecutoff=0.01) head(yy) ## End(Not run) enrichkegg KEGG Enrichment Analysis of a gene set. Given a vector of genes, this function will return the enrichment KEGG categories with FDR control. KEGG Enrichment Analysis of a gene set. Given a vector of genes, this function will return the enrichment KEGG categories with FDR control. enrichkegg(gene, organism = "hsa", keytype = "kegg", pvaluecutoff = 0.05, padjustmethod = "BH", universe, mingssize = 10, maxgssize = 500, qvaluecutoff = 0.2, use_internal_data = FALSE) gene organism keytype pvaluecutoff padjustmethod universe mingssize maxgssize a vector of entrez gene id. supported organism listed in one of "kegg", ncbi-geneid, ncib-proteinid and uniprot Cutoff value of pvalue. one of "holm", "hochberg", "hommel", "bonferroni", "BH", "BY", "fdr", "none" background genes minimal size of genes annotated by Ontology term for testing. maximal size of genes annotated for testing qvaluecutoff qvalue cutoff use_internal_data logical, use KEGG.db or latest online KEGG data A enrichresult instance. See Also enrichresult-class, comparecluster

12 12 enrichmkegg Examples data(genelist) de <- names(genelist)[1:100] yy <- enrichkegg(de, pvaluecutoff=0.01) head(yy) #plot(yy) enrichmkegg KEGG Module Enrichment Analysis of a gene set. Given a vector of genes, this function will return the enrichment KEGG Module categories with FDR control. KEGG Module Enrichment Analysis of a gene set. Given a vector of genes, this function will return the enrichment KEGG Module categories with FDR control. enrichmkegg(gene, organism = "hsa", keytype = "kegg", pvaluecutoff = 0.05, padjustmethod = "BH", universe, mingssize = 10, maxgssize = 500, qvaluecutoff = 0.2) gene organism keytype pvaluecutoff padjustmethod universe mingssize maxgssize qvaluecutoff a vector of entrez gene id. supported organism listed in one of "kegg", ncbi-geneid, ncib-proteinid and uniprot Cutoff value of pvalue. one of "holm", "hochberg", "hommel", "bonferroni", "BH", "BY", "fdr", "none" background genes minimal size of genes annotated by Ontology term for testing. maximal size of genes annotated for testing qvalue cutoff A enrichresult instance.

13 fortify.compareclusterresult 13 fortify.compareclusterresult fortify convert compareclusterresult to a data.frame that ready for plot ## S3 method for class 'compareclusterresult' fortify(model, data, showcategory = 5, by = "generatio", split = NULL, includeall = TRUE) model data showcategory by split includeall compareclusterresult object not use here category numbers one of generatio, Percentage or count ONTOLOGY or NULL logical data.frame getgolevel get GOIDs at a specific level query GOIDs at a specific level. getgolevel(ont, level) ont level Ontology GO level

14 14 go2ont a vector of GOIDs Gff2GeneTable Gff2GeneTable read GFF file and build gene information table Gff2GeneTable(gffFile, compress = TRUE) gfffile compress GFF file compress file or not Details given a GFF file, this function extracts information from it and save it in working directory file save. Yu Guangchuang go2ont go2ont convert goid to ontology (BP, CC, MF) go2ont(goid) goid a vector of GO IDs

15 go2term 15 data.frame go2term go2term convert goid to descriptive term go2term(goid) goid a vector of GO IDs data.frame gofilter gofilter filter GO enriched result at specific level gofilter(x, level = 4) x level output from enrichgo or comparecluster GO level updated object

16 16 groupgo groupgo Functional Profile of a gene set at specific GO level. Given a vector of genes, this function will return the GO profile at a specific level. Functional Profile of a gene set at specific GO level. Given a vector of genes, this function will return the GO profile at a specific level. groupgo(gene, OrgDb, keytype = "ENTREZID", ont = "CC", level = 2, readable = FALSE) gene OrgDb keytype ont level readable a vector of entrez gene id. OrgDb key type of input gene One of "MF", "BP", and "CC" subontologies. Specific GO Level. if readable is TRUE, the gene IDs will mapping to gene symbols. A groupgoresult instance. See Also groupgoresult-class, comparecluster Examples data(gcsample) yy <- groupgo(gcsample[[1]], 'org.hs.eg.db', ont="bp", level=2) head(summary(yy)) #plot(yy)

17 groupgoresult-class 17 groupgoresult-class Class "groupgoresult" This class represents the result of functional Profiles of a set of gene at specific GO level. Slots Class "groupgoresult" This class represents the result of functional Profiles of a set of gene at specific GO level. result GO classification result ontology Ontology level GO level organism one of "human", "mouse" and "yeast" gene Gene IDs readable logical flag of gene ID in symbol or not. See Also compareclusterresult comparecluster groupgo GSEA GSEA a universal gene set enrichment analysis tools GSEA(geneList, exponent = 1, nperm = 1000, mingssize = 10, maxgssize = 500, pvaluecutoff = 0.05, padjustmethod = "BH", TERM2GENE, TERM2NAME = NA, verbose = TRUE, seed = FALSE, by = "fgsea") genelist exponent nperm mingssize maxgssize pvaluecutoff order ranked genelist weight of each step number of permutations minimal size of each geneset for analyzing maximal size of genes annotated for testing pvalue cutoff

18 18 gsego padjustmethod TERM2GENE TERM2NAME verbose seed by p value adjustment method user input annotation of TERM TO GENE mapping, a data.frame of 2 column with term and gene user input of TERM TO NAME mapping, a data.frame of 2 column with term and name logical logical one of fgsea or DOSE gsearesult object gsego gsego Gene Set Enrichment Analysis of Gene Ontology gsego(genelist, ont = "BP", OrgDb, keytype = "ENTREZID", exponent = 1, nperm = 1000, mingssize = 10, maxgssize = 500, pvaluecutoff = 0.05, padjustmethod = "BH", verbose = TRUE, seed = FALSE, by = "fgsea") genelist ont OrgDb keytype exponent nperm mingssize maxgssize pvaluecutoff padjustmethod verbose seed by order ranked genelist one of "BP", "MF", "CC" or "GO" OrgDb keytype of gene weight of each step permutation numbers minimal size of each geneset for analyzing maximal size of genes annotated for testing pvalue Cutoff pvalue adjustment method print message or not logical one of fgsea or DOSE

19 gsekegg 19 gsearesult object Yu Guangchuang gsekegg gsekegg Gene Set Enrichment Analysis of KEGG gsekegg(genelist, organism = "hsa", keytype = "kegg", exponent = 1, nperm = 1000, mingssize = 10, maxgssize = 500, pvaluecutoff = 0.05, padjustmethod = "BH", verbose = TRUE, use_internal_data = FALSE, seed = FALSE, by = "fgsea") genelist organism keytype exponent nperm mingssize maxgssize pvaluecutoff padjustmethod order ranked genelist supported organism listed in one of "kegg", ncbi-geneid, ncib-proteinid and uniprot weight of each step permutation numbers minimal size of each geneset for analyzing maximal size of genes annotated for testing pvalue Cutoff pvalue adjustment method verbose print message or not use_internal_data logical, use KEGG.db or latest online KEGG data seed by logical one of fgsea or DOSE gsearesult object Yu Guangchuang

20 20 gsemkegg gsemkegg gsemkegg Gene Set Enrichment Analysis of KEGG Module gsemkegg(genelist, organism = "hsa", keytype = "kegg", exponent = 1, nperm = 1000, mingssize = 10, maxgssize = 500, pvaluecutoff = 0.05, padjustmethod = "BH", verbose = TRUE, seed = FALSE, by = "fgsea") genelist organism keytype exponent nperm mingssize maxgssize pvaluecutoff padjustmethod verbose seed by order ranked genelist supported organism listed in one of "kegg", ncbi-geneid, ncib-proteinid and uniprot weight of each step permutation numbers minimal size of each geneset for analyzing maximal size of genes annotated for testing pvalue Cutoff pvalue adjustment method print message or not logical one of fgsea or DOSE gsearesult object Yu Guangchuang

21 idtype 21 idtype idtype list ID types supported by annodb idtype(orgdb = "org.hs.eg.db") OrgDb annotation db character vector KEGG_path2extid KEGG_path2extid query all genes in a KEGG pathway or module KEGG_path2extid(keggID, species = sub("\\d+$", "", keggid), keggtype = "Path", keytype = "kegg") keggid species keggtype keytype KEGG ID, path or module ID species one of Path or Module KEGG gene type, one of "ncbi-proteinid", "ncbi-geneid", "uniprot", or "kegg" extid vector guangchuang yu

22 22 merge_result ko2name ko2name convert ko ID to descriptive name ko2name(ko) ko ko ID data.frame guangchuang yu merge_result merge_result merge a list of enrichresult objects to compareclusterresult merge_result(enrichresultlist) enrichresultlist a list of enrichresult objects a compareclusterresult instance

23 plot 23 plot plot method plot method generics ## S4 method for signature 'compareclusterresult,any' plot(x, type = "dot", colorby = "p.adjust", showcategory = 5, by = "generatio", split = NULL, includeall = TRUE, font.size = 12, title = "") x type colorby showcategory by split includeall font.size title compareclusterresult object one of bar or dot one of pvalue or p.adjust category numbers one of generatio, Percentage or count ONTOLOGY or NULL logical font size figure title... Additional argument list plot plotgograph plotgograph plot GO graph plotgograph(x, firstsignodes = 10, useinfo = "all", sigforall = TRUE, usefullnames = TRUE,...)

24 24 plotting.clusterprofile x firstsignodes useinfo sigforall usefullnames output of enrichgo or gsego number of significant nodes (retangle nodes in the graph) additional info if TRUE the score/p-value of all nodes in the DAG is shown, otherwise only score will be shown logical... additional parameter of showsigofnodes, please refer to topgo GO DAG graph See Also showsigofnodes plotting.clusterprofile plotting-clusterprofile Internal plot function for plotting compareclusterresult plotting.clusterprofile(clprof.reshape.df, x = ~Cluster, type = "dot", colorby = "p.adjust", by = "generatio", title = "", font.size = 12) clprof.reshape.df data frame of comparecluster result x type colorby by title font.size ggplot object x variable one of dot and bar one of pvalue or p.adjust one of percentage and count graph title graph font size

25 read.gmt 25 read.gmt read.gmt parse gmt file to a data.frame read.gmt(gmtfile) gmtfile gmt file data.frame search_kegg_organism search_kegg_organism search kegg organism, listed in search_kegg_organism(str, by = "scientific_name", ignore.case = FALSE) str by ignore.case string one of kegg.code, scientific_name and common_name TRUE or FALSE data.frame

26 26 simplify simplify simplify method simplify output from enrichgo by removing redundancy of enriched GO terms simplify output from comparecluster by removing redundancy of enriched GO terms ## S4 method for signature 'enrichresult' simplify(x, cutoff = 0.7, by = "p.adjust", select_fun = min, measure = "Wang", semdata = NULL) ## S4 method for signature 'compareclusterresult' simplify(x, cutoff = 0.7, by = "p.adjust", select_fun = min, measure = "Wang", semdata = NULL) x cutoff by select_fun measure semdata output of enrichgo similarity cutoff feature to select representative term, selected by select_fun function function to select feature passed by by parameter method to measure similarity GOSemSimDATA object updated enrichresult object updated compareclusterresult object References issue #28

27 viewkegg 27 viewkegg viewkegg function is for visualize KEGG pathways works with enrichresult object to visualize enriched KEGG pathway viewkegg function is for visualize KEGG pathways works with enrichresult object to visualize enriched KEGG pathway viewkegg(obj, pathwayid, foldchange, color.low = "green", color.high = "red", kegg.native = TRUE, out.suffix = "clusterprofiler") obj pathwayid foldchange color.low color.high kegg.native out.suffix enrichresult object pathway ID or index fold change values color of low foldchange genes color of high foldchange genes logical suffix of output file References Luo et al. (2013) Pathview: an R/Bioconductor package for pathway-based data integration and visualization. Bioinformatics (Oxford, England), 29: , ISSN bioinformatics.oxfordjournals.org/content/abstract/29/14/1830.abstract PMID:

28 Index Topic classes compareclusterresult-class, 6 groupgoresult-class, 17 Topic datasets DataSet, 6 Topic manip comparecluster, 5 enrichgo, 10 enrichkegg, 11 groupgo, 16 gofilter, 15 groupgo, 5, 16, 17 groupgoresult, 6 groupgoresult-class, 17 GSEA, 17 gsego, 18 gsekegg, 19 gsemkegg, 20 idtype, 21 bitr, 3 bitr_kegg, 3 browsekegg, 4 buildgomap, 4 clusterprofiler (clusterprofiler-package), 2 clusterprofiler-package, 2 comparecluster, 5, 6, 10, 11, 16, 17 compareclusterresult, 17 compareclusterresult-class, 6 DataSet, 6 dotplot,compareclusterresult,any-method (dotplot,compareclusterresult-method), 7 dotplot,compareclusterresult-method, 7 download_kegg, 7 dropgo, 8 enrichdavid, 8 enricher, 9 enrichgo, 5, 10 enrichkegg, 11 enrichmkegg, 12 enrichresult, 6 fortify.compareclusterresult, 13 gcsample (DataSet), 6 getgolevel, 13 Gff2GeneTable, 14 go2ont, 14 go2term, KEGG_path2extid, 21 kegg_species (DataSet), 6 ko2name, 22 merge_result, 22 plot, 23 plot,compareclusterresult,any-method (plot), 23 plot,compareclusterresult-method (compareclusterresult-class), 6 plotgograph, 23 plotting.clusterprofile, 24 read.gmt, 25 search_kegg_organism, 25 show,compareclusterresult-method (compareclusterresult-class), 6 show,groupgoresult-method (groupgoresult-class), 17 showsigofnodes, 24 simplify, 26 simplify,compareclusterresult-method (simplify), 26 simplify,enrichresult-method (simplify), 26 summary,compareclusterresult-method (compareclusterresult-class), 6 viewkegg, 27

Package clusterprofiler

Package clusterprofiler Type Package Package clusterprofiler December 22, 2018 Title statistical analysis and visualization of functional profiles for genes and gene clusters Version 3.10.1 Maintainer

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

Package methylgsa. March 7, 2019 Package methylgsa March 7, 2019 Type Package Title Gene Set Analysis Using the Outcome of Differential Methylation Version 1.1.3 The main functions for methylgsa are methylglm and methylrra. methylgsa

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 NFP. November 21, 2016

Package NFP. November 21, 2016 Type Package Title Network Fingerprint Framework in R Version 0.99.2 Date 2016-11-19 Maintainer Yang Cao Package NFP November 21, 2016 An implementation of the network fingerprint

More information

Using clusterprofiler to identify and compare functional profiles of gene lists

Using clusterprofiler to identify and compare functional profiles of gene lists Using clusterprofiler to identify and compare functional profiles of gene lists Guangchuang Yu School of Biological Sciences The University of Hong Kong, Hong Kong SAR, China email: gcyu@connect.hku.hk

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 categorycompare

Package categorycompare Version 1.24.0 Package categorycompare August 31, 2018 Title Meta-analysis of high-throughput experiments using feature annotations Author Robert M. Flight Maintainer Robert M. Flight

More information

Package GOFunction. April 13, 2019

Package GOFunction. April 13, 2019 Type Package Package GOFunction April 13, 2019 Title GO-function: deriving biologcially relevant functions from statistically significant functions Version 1.30.0 Date 2013-10-03 Author

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

Network Enrichment Analysis using neagui Package

Network Enrichment Analysis using neagui Package Network Enrichment Analysis using neagui Package Setia Pramana, Woojoo Lee, Andrey Alexeyenko, Yudi Pawitan April 2, 2013 1 Introduction After discovering list of differentially expressed genes, the next

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 treeio. January 1, 2019

Package treeio. January 1, 2019 Package treeio January 1, 2019 Title Base Classes and Functions for Phylogenetic Tree Input and Output Version 1.7.2 Base classes and functions for parsing and exporting phylogenetic trees. 'treeio' supports

More information

Package treeio. April 1, 2018

Package treeio. April 1, 2018 Package treeio April 1, 2018 Title Base Classes and Functions for Phylogenetic Tree Input and Output Version 1.3.13 Base classes and functions for parsing and exporting phylogenetic trees. 'treeio' supports

More information

Package geecc. October 9, 2015

Package geecc. October 9, 2015 Type Package Package geecc October 9, 2015 Title Gene set Enrichment analysis Extended to Contingency Cubes Version 1.2.0 Date 2014-12-31 Author Markus Boenn Maintainer Markus Boenn

More information

Package tidytree. June 13, 2018

Package tidytree. June 13, 2018 Package tidytree June 13, 2018 Title A Tidy Tool for Phylogenetic Tree Data Manipulation Version 0.1.9 Phylogenetic tree generally contains multiple components including node, edge, branch and associated

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 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 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 KEGGprofile. February 10, 2018

Package KEGGprofile. February 10, 2018 Type Package Package KEGGprofile February 10, 2018 Title An annotation and visualization package for multi-types and multi-groups expression data in KEGG pathway Version 1.20.0 Date 2017-10-30 Author Shilin

More information

Package pcagopromoter

Package pcagopromoter Version 1.26.0 Date 2012-03-16 Package pcagopromoter November 13, 2018 Title pcagopromoter is used to analyze DNA micro array data Author Morten Hansen, Jorgen Olsen Maintainer Morten Hansen

More information

Package PGSEA. R topics documented: May 4, Type Package Title Parametric Gene Set Enrichment Analysis Version 1.54.

Package PGSEA. R topics documented: May 4, Type Package Title Parametric Gene Set Enrichment Analysis Version 1.54. Type Package Title Parametric Gene Set Enrichment Analysis Version 1.54.0 Date 2012-03-22 Package PGSEA May 4, 2018 Author Kyle Furge and Karl Dykema Maintainer

More information

Package rgreat. June 19, 2018

Package rgreat. June 19, 2018 Type Package Title Client for GREAT Analysis Version 1.12.0 Date 2018-2-20 Author Zuguang Gu Maintainer Zuguang Gu Package rgreat June 19, 2018 Depends R (>= 3.1.2), GenomicRanges, IRanges,

More information

Package geecc. R topics documented: December 7, Type Package

Package geecc. R topics documented: December 7, Type Package Type Package Package geecc December 7, 2018 Title Gene Set Enrichment Analysis Extended to Contingency Cubes Version 1.16.0 Date 2016-09-19 Author Markus Boenn Maintainer Markus Boenn

More information

safe September 23, 2010

safe September 23, 2010 safe September 23, 2010 SAFE-class Class SAFE Slots The class SAFE is the output from the function safe. It is also the input to the plotting function safeplot. local: Object of class "character" describing

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 cregulome. September 13, 2018

Package cregulome. September 13, 2018 Type Package Version 0.2.0 Package cregulome September 13, 2018 Title Obtain and Visualize Regulome-Gene Expression Correlations in Cancer Builds a 'SQLite' database file of pre-calculated transcription

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 TFutils. October 11, 2018

Package TFutils. October 11, 2018 Title TFutils Package to work with TF data. Version 1.0.0 Depends R (>= 3.5.0) Package TFutils October 11, 2018 Imports methods, GenomicRanges, IRanges, S4Vectors, GSEABase, shiny, miniui, data.table,

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 OmaDB. R topics documented: December 19, Title R wrapper for the OMA REST API Version Author Klara Kaleb

Package OmaDB. R topics documented: December 19, Title R wrapper for the OMA REST API Version Author Klara Kaleb Title R wrapper for the OMA REST API Version 1.2.0 Author Klara Kaleb Package OmaDB December 19, 2018 Maintainer Klara Kaleb , Adrian Altenhoff A

More information

Package darksky. September 20, 2017

Package darksky. September 20, 2017 Type Package Title Tools to Work with the 'Dark Sky' 'API' Version 1.3.0 Date 2017-09-20 Maintainer Bob Rudis Package darksky September 20, 2017 Provides programmatic access to the 'Dark Sky'

More information

Package mirnatap. February 1, 2018

Package mirnatap. February 1, 2018 Type Package Package mirnatap February 1, 2018 Title mirnatap: microrna Targets - Aggregated Predictions Version 1.13.0 Date 2016-10-03 Author Maciej Pajak, T. Ian Simpson Maintainer The package facilitates

More information

Package RcisTarget. July 17, 2018

Package RcisTarget. July 17, 2018 Type Package Package RcisTarget July 17, 2018 Title RcisTarget: Identify transcription factor binding motifs enriched on a gene list Version 1.1.2 Date 2018-05-26 Author Sara Aibar, Gert Hulselmans, Stein

More information

Package robotstxt. November 12, 2017

Package robotstxt. November 12, 2017 Date 2017-11-12 Type Package Package robotstxt November 12, 2017 Title A 'robots.txt' Parser and 'Webbot'/'Spider'/'Crawler' Permissions Checker Version 0.5.2 Provides functions to download and parse 'robots.txt'

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 splinetimer. December 22, 2016

Package splinetimer. December 22, 2016 Type Package Package splinetimer December 22, 2016 Title Time-course differential gene expression data analysis using spline regression models followed by gene association network reconstruction Version

More information

Package reval. May 26, 2015

Package reval. May 26, 2015 Package reval May 26, 2015 Title Repeated Function Evaluation for Sensitivity Analysis Version 2.0.0 Date 2015-05-25 Author Michael C Koohafkan [aut, cre] Maintainer Michael C Koohafkan

More information

Package SIMLR. December 1, 2017

Package SIMLR. December 1, 2017 Version 1.4.0 Date 2017-10-21 Package SIMLR December 1, 2017 Title Title: SIMLR: Single-cell Interpretation via Multi-kernel LeaRning Maintainer Daniele Ramazzotti Depends

More information

Package GSCA. October 12, 2016

Package GSCA. October 12, 2016 Type Package Title GSCA: Gene Set Context Analysis Version 2.2.0 Date 2015-12-8 Author Zhicheng Ji, Hongkai Ji Maintainer Zhicheng Ji Package GSCA October 12, 2016 GSCA takes as input several

More information

Package GSCA. April 12, 2018

Package GSCA. April 12, 2018 Type Package Title GSCA: Gene Set Context Analysis Version 2.8.0 Date 2015-12-8 Author Zhicheng Ji, Hongkai Ji Maintainer Zhicheng Ji Package GSCA April 12, 2018 GSCA takes as input several

More information

Package CTDquerier. March 8, 2019

Package CTDquerier. March 8, 2019 Package CTDquerier March 8, 2019 Title Package for CTDbase data query, visualization and downstream analysis Version 1.2.0 Maintainer Carles Hernandez-Ferrer Package to

More information

Package transcriptogramer

Package transcriptogramer Type Package Package transcriptogramer January 4, 2019 Title Transcriptional analysis based on transcriptograms Version 1.4.1 Date 2018-11-28 R package for transcriptional analysis based on transcriptograms,

More information

Package Organism.dplyr

Package Organism.dplyr Package Organism.dplyr January 9, 2019 Title dplyr-based Access to Bioconductor Annotation Resources Version 1.11.0 Description This package provides an alternative interface to Bioconductor 'annotation'

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 QUBIC. September 1, 2018

Package QUBIC. September 1, 2018 Type Package Package QUBIC September 1, 2018 Title An R package for qualitative biclustering in support of gene co-expression analyses The core function of this R package is to provide the implementation

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 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 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 CePa. R topics documented: June 4, 2018

Package CePa. R topics documented: June 4, 2018 Type Package Title Centrality-Based Pathway Enrichment Version 0.6 Date 2018-06-04 Author Zuguang Gu Maintainer Zuguang Gu Depends R (>= 2.10.0) Package CePa June 4, 2018 Imports igraph

More information

org.hs.ipi.db November 7, 2017 annotation data package

org.hs.ipi.db November 7, 2017 annotation data package org.hs.ipi.db November 7, 2017 org.hs.ipi.db annotation data package Welcome to the org.hs.ipi.db annotation Package. The annotation package was built using a downloadable R package - PAnnBuilder (download

More information

Package KEGGlincs. April 12, 2019

Package KEGGlincs. April 12, 2019 Type Package Package KEGGlincs April 12, 2019 Title Visualize all edges within a KEGG pathway and overlay LINCS data [option] Version 1.8.0 Date 2016-06-02 Author Shana White Maintainer Shana White ,

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

ClueGO - CluePedia Frequently asked questions

ClueGO - CluePedia Frequently asked questions ClueGO - CluePedia Frequently asked questions Gabriela Bindea, Bernhard Mlecnik Laboratory of Integrative Cancer Immunology INSERM U872 Cordeliers Research Center Paris, France Contents License...............................................................

More information

SEEK User Manual. Introduction

SEEK User Manual. Introduction SEEK User Manual Introduction SEEK is a computational gene co-expression search engine. It utilizes a vast human gene expression compendium to deliver fast, integrative, cross-platform co-expression analyses.

More information

Package geneslope. October 26, 2016

Package geneslope. October 26, 2016 Type Package Package geneslope October 26, 2016 Title Genome-Wide Association Study with SLOPE Version 0.37.0 Date 2016-10-26 Genome-wide association study (GWAS) performed with SLOPE, short for Sorted

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 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 graphite. June 29, 2018

Package graphite. June 29, 2018 Version 1.27.2 Date 2018-05-22 Package graphite June 29, 2018 Title GRAPH Interaction from pathway Topological Environment Author Gabriele Sales , Enrica Calura ,

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 sigora. September 28, 2018

Package sigora. September 28, 2018 Type Package Title Signature Overrepresentation Analysis Version 3.0.1 Date 2018-9-28 Package sigora September 28, 2018 Author Amir B.K. Foroushani, Fiona S.L. Brinkman, David J. Lynn Maintainer Amir Foroushani

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 githubinstall

Package githubinstall Type Package Version 0.2.2 Package githubinstall February 18, 2018 Title A Helpful Way to Install R Packages Hosted on GitHub Provides an helpful way to install packages hosted on GitHub. URL https://github.com/hoxo-m/githubinstall

More information

Package messaging. May 27, 2018

Package messaging. May 27, 2018 Type Package Package messaging May 27, 2018 Title Conveniently Issue Messages, Warnings, and Errors Version 0.1.0 Description Provides tools for creating and issuing nicely-formatted text within R diagnostic

More information

KEGG.db. August 19, Bioconductor annotation data package

KEGG.db. August 19, Bioconductor annotation data package KEGG.db August 19, 2018 KEGG.db Bioconductor annotation data package Welcome to the KEGG.db annotation Package. The purpose of this package was to provide detailed information about the latest version

More information

User s Guide. Using the R-Peridot Graphical User Interface (GUI) on Windows and GNU/Linux Systems

User s Guide. Using the R-Peridot Graphical User Interface (GUI) on Windows and GNU/Linux Systems User s Guide Using the R-Peridot Graphical User Interface (GUI) on Windows and GNU/Linux Systems Pitágoras Alves 01/06/2018 Natal-RN, Brazil Index 1. The R Environment Manager...

More information

PathWave: short manual Version 1.0 February 4th, 2009

PathWave: short manual Version 1.0 February 4th, 2009 PathWave: short manual Version 1.0 February 4th, 2009 This manual gives a short introduction into the usage of the R package PathWave. PathWave enables the user to easily analyse gene expression data considering

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

WebGestalt Manual. January 30, 2013

WebGestalt Manual. January 30, 2013 WebGestalt Manual January 30, 2013 The Web-based Gene Set Analysis Toolkit (WebGestalt) is a suite of tools for functional enrichment analysis in various biological contexts. WebGestalt compares a user

More information

Bioconductor annotation packages

Bioconductor annotation packages Bioconductor annotation packages Major types of annotation in Bioconductor. AnnotationDbi packages: Organism level: org.mm.eg.db. Platform level: hgu133plus2.db. System-biology level: GO.db or KEGG.db.

More information

Package PSICQUIC. January 18, 2018

Package PSICQUIC. January 18, 2018 Package PSICQUIC January 18, 2018 Type Package Title Proteomics Standard Initiative Common QUery InterfaCe Version 1.17.3 Date 2018-01-16 Author Paul Shannon Maintainer Paul Shannon

More information

Package splithalf. March 17, 2018

Package splithalf. March 17, 2018 Type Package Package splithalf March 17, 2018 Title Calculate Task Split Half Reliability Estimates Version 0.3.1 Maintainer Sam Parsons A series of functions to calculate the

More information

How To Use GOstats and Category to do Hypergeometric testing with unsupported model organisms

How To Use GOstats and Category to do Hypergeometric testing with unsupported model organisms How To Use GOstats and Category to do Hypergeometric testing with unsupported model organisms M. Carlson October 30, 2017 1 Introduction This vignette is meant as an extension of what already exists in

More information

Package wikitaxa. December 21, 2017

Package wikitaxa. December 21, 2017 Title Taxonomic Information from 'Wikipedia' Package wikitaxa December 21, 2017 'Taxonomic' information from 'Wikipedia', 'Wikicommons', 'Wikispecies', and 'Wikidata'. Functions included for getting taxonomic

More information

mgu74a.db November 2, 2013 Map Manufacturer identifiers to Accession Numbers

mgu74a.db November 2, 2013 Map Manufacturer identifiers to Accession Numbers mgu74a.db November 2, 2013 mgu74aaccnum Map Manufacturer identifiers to Accession Numbers mgu74aaccnum is an R object that contains mappings between a manufacturer s identifiers and manufacturers accessions.

More information

ygs98.db December 22,

ygs98.db December 22, ygs98.db December 22, 2018 ygs98alias Map Open Reading Frame (ORF) Identifiers to Alias Gene Names A set of gene names may have been used to report yeast genes represented by ORF identifiers. One of these

More information

Package opencage. January 16, 2018

Package opencage. January 16, 2018 Package opencage January 16, 2018 Type Package Title Interface to the OpenCage API Version 0.1.4 Tool for accessing the OpenCage API, which provides forward geocoding (from placename to longitude and latitude)

More information

mogene20sttranscriptcluster.db

mogene20sttranscriptcluster.db mogene20sttranscriptcluster.db November 17, 2017 mogene20sttranscriptclusteraccnum Map Manufacturer identifiers to Accession Numbers mogene20sttranscriptclusteraccnum is an R object that contains mappings

More information

Package FSelectorRcpp

Package FSelectorRcpp Type Package Package FSelectorRcpp November 12, 2018 Title 'Rcpp' Implementation of 'FSelector' Entropy-Based Feature Selection Algorithms with a Sparse Matrix Support Version 0.3.0 Description 'Rcpp'

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 mirnapath. July 18, 2013

Package mirnapath. July 18, 2013 Type Package Package mirnapath July 18, 2013 Title mirnapath: Pathway Enrichment for mirna Expression Data Version 1.20.0 Author James M. Ward with contributions from Yunling Shi,

More information

Package fingertipsr. May 25, Type Package Version Title Fingertips Data for Public Health

Package fingertipsr. May 25, Type Package Version Title Fingertips Data for Public Health Type Package Version 0.1.7 Title Fingertips Data for Public Health Package fingertipsr May 25, 2018 Fingertips () contains data for many indicators of public health in England.

More information

Package vip. June 15, 2018

Package vip. June 15, 2018 Type Package Title Variable Importance Plots Version 0.1.0 Package vip June 15, 2018 A general framework for constructing variable importance plots from various types machine learning models in R. Aside

More information

Package semisup. March 10, Version Title Semi-Supervised Mixture Model

Package semisup. March 10, Version Title Semi-Supervised Mixture Model Version 1.7.1 Title Semi-Supervised Mixture Model Package semisup March 10, 2019 Description Useful for detecting SNPs with interactive effects on a quantitative trait. This R packages moves away from

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 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 prozor. July 26, 2018

Package prozor. July 26, 2018 Type Package Package prozor July 26, 2018 Title Minimal Protein Set Explaining Peptide Spectrum Matches Version 0.2.11 Author Witold Wolski Maintainer Witold Wolski Determine minimal

More information

Package RDAVIDWebService

Package RDAVIDWebService Package RDAVIDWebService November 1, 2013 Type Package Title An R Package for retrieving data from DAVID into R objects using Web Services API. Version 1.0.0 Date 2013-02-04 Author Cristobal Fresno and

More information

Package igc. February 10, 2018

Package igc. February 10, 2018 Type Package Package igc February 10, 2018 Title An integrated analysis package of Gene expression and Copy number alteration Version 1.8.0 This package is intended to identify differentially expressed

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

Package EGSEA. July 7, 2018 Title Ensemble of Gene Set Enrichment Analyses Version 1.8.0 Date 24-08-2017 Package EGSEA July 7, 2018 Author Monther Alhamdoosh, Luyi Tian, Milica Ng and Matthew Ritchie Maintainer Monther Alhamdoosh

More information

Package SeqGSEA. October 4, 2013

Package SeqGSEA. October 4, 2013 Package SeqGSEA October 4, 2013 Type Package Title Gene Set Enrichment Analysis (GSEA) of RNA-Seq Data: integrating differential expression and splicing Version 1.0.2 Date 2013-05-01 Author Xi Wang

More information

Package BiocManager. November 13, 2018

Package BiocManager. November 13, 2018 Package BiocManager November 13, 2018 Title Access the Bioconductor Project Package Repository A convenient tool to install and update Bioconductor packages. Version 1.30.4 Depends R (>= 3.5.0) Imports

More information

Package benchmarkme. R topics documented: February 26, Type Package Title Crowd Sourced System Benchmarks Version 0.2.

Package benchmarkme. R topics documented: February 26, Type Package Title Crowd Sourced System Benchmarks Version 0.2. Type Package Title Crowd Sourced System Benchmarks Version 0.2.3 Date 2016-02-26 Package benchmarkme February 26, 2016 Maintainer Colin Gillespie Benchmark your CPU and compare

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

DAVID hands-on. by Ester Feldmesser, June 2017

DAVID hands-on. by Ester Feldmesser, June 2017 DAVID hands-on by Ester Feldmesser, June 2017 1. Go to the DAVID website (http://david.abcc.ncifcrf.gov/) 2. Press on Start Analysis: 3. Choose the Upload tab in the left panel: 4. Download the k-means5_arabidopsis.txt

More information