GO Tools: Slimmers
AmiGO
- Platform
- Developer
- GO Consortium.
- Contact
- GO Helpdesk
- Publications
- PMID:19033274
- License
- Free for academic use
- GO data updates
- daily
- GO data used
- terms
- definitions and comments
- synonyms
- cross-references
- relationships
- subsets or GO slims
- gene product data
- taxon
- evidence codes
- references
- qualifiers
AmiGO provides an interface to search and browse the ontology and annotation data provided by the GO consortium. Users can search for gene products and view the terms with which they are associated; alternatively, users can search or browse the ontology for GO terms of interest and see term details and gene product annotations. AmiGO also provides a BLAST search engine, which searches the sequences of genes and gene products that have been annotated to a GO term and submitted to the GO Consortium.
AmiGO accesses the GO mySQL database; more information is available from the GO database guide.
- ontology or annotation browser
- ontology or annotation search engine
- ontology or annotation visualization
- slimmer-type tool
- term enrichment
- other analysis
Tool listing last updated 10 October 2010
CateGOrizer
- Platform
- Developer
- US National Animal Genome Research Program, Ames, Iowa, USA.
- Contact
- Zhiliang Hu
- License
- Free for academic use
- GO data updates
- every three months (or more frequently)
- GO data used
- terms
- definitions and comments
- synonyms
- cross-references
- relationships
- subsets or GO slims
- gene product data
- taxon
- evidence codes
- references
- qualifiers
CateGOrizer takes batch input of GO term IDs in a list format or unformatted plain text file, allows users to choose one of the available classifications such as GO_slim, GOA, EGAD, MGI_GO_slim, GO-ROOT, or a self-defined classification list, find its parental "branch" and performs an accumulative classification count, and returns the results in a sorted table of counts, percentages, and a pie chart (if it takes longer than standard "time out" period, it will email the user with a URL link to the results).
- statistical analysis
- slimmer-type tool
- GO Terms classification (by predefined parental GO terms such as GO Slim).
Tool listing last updated 03 June 2010
g:Profiler
- Platform
- Developer
- BIIT Group, Institute of Computer Science, University of Tartu, Tartu, Estonia.
- Contact
- BIIT support
- Publications
- PMID:17478515
- License
- Free for academic use
- GO data updates
- every three months (or more frequently)
- GO data used
- terms
- definitions and comments
- synonyms
- cross-references
- relationships
- subsets or GO slims
- gene product data
- taxon
- evidence codes
- references
- qualifiers
g:Profiler is a public web server for characterising and manipulating gene lists from high-throughput genomic data. g:Profiler has a simple user-friendly web interface with powerful visualisation. g:Profiler currently supports 85 species, including mammals, fungi, plants, insects, etc, from the Ensembl and Ensembl Genomes databases. g:Profiler consists of the following tools:
- g:GOSt retrieves most significant Gene Ontology (GO) terms, KEGG and REACTOME pathways, and TRANSFAC motifs to a user-specified group of genes, proteins or microarray probes. g:GOSt also allows analysis of ranked or ordered lists of genes, visual browsing of GO graph structure, interactive visualisation of retrieved results, and many other features. Multiple testing corrections are applied to extract only statistically important results.
- g:Convert allows conversion between gene or protein names, database IDs and microarray probes of more than 100 types. A mix of various IDs may be presented as input; output options include HTML, text and XLS spreadsheet.
- g:Orth retrieves orthologs for a given set of genes, proteins or probes in a selected organism. Graphical representation also shows orthologs present in all g:Profiler organisms.
- g:Sorter searches for similar expression profiles to a given gene, protein or probe in a large set of public microarray datasets from the Gene Expression Omnibus (GEO) database.
- g:Cocoa provides a compact interface for comparing enrichments of multiple gene lists.
- ontology or annotation visualization
- statistical analysis
- slimmer-type tool
- term enrichment
- protein interactions
- functional similarity
- other analysis
- coexpression similarity search, Gene ID conversion, network enrichment analysis., orthology mapping, search by genomic locus
Tool listing last updated 26 January 2011
GeneMerge
- Platform
- Developer
- Castillo-Davis Laboratory, University of Maryland, Maryland, USA.
- Contact
- Dr. Cristian Castillo-Davis
- Publications
- PMID:12724301
- License
- Free for academic use
- GO data updates
- every three months (or more frequently)
- GO data used
- terms
- definitions and comments
- synonyms
- cross-references
- relationships
- subsets or GO slims
- gene product data
- taxon
- evidence codes
- references
- qualifiers
GeneMerge is a web-based and standalone application that returns a wide range of functional genomic data for a given set of study genes and provides rank scores for over-representation of particular functions or categories in the data. GeneMerge uses the hypergeometric test statistic which returns statistically correct results for samples of all sizes and is the #2 fastest GO tool available (Khatri and Draghici, 2005). GeneMerge can be used with any discrete, locus-based annotation data, including, literature references, genetic interactions, mutant phenotypes as well as traditional Gene Ontology queries.
- statistical analysis
- slimmer-type tool
- term enrichment
- text mining
- false discovery rate and Bonferroni correction
Tool listing last updated 14 January 2011
Generic GO Term Mapper
- Platform
- Developer
- Lewis-Sigler Institute for Integrative Genomics, Princeton University, Princeton, New Jersey, USA.
- Contact
- Mark Schroeder
- License
- Free for academic use
- GO data updates
- daily
- GO data used
- terms
- definitions and comments
- synonyms
- cross-references
- relationships
- subsets or GO slims
- gene product data
- taxon
- evidence codes
- references
- qualifiers
The Generic GO Term Mapper finds the GO terms shared among a list of genes from your organism of choice within a slim ontology, allowing them to be binned into broader categories. The user may optionally provide a custom gene association file or slim ontology, or a custom list of slim terms.
- slimmer-type tool
- term enrichment
Tool listing last updated 19 February 2011
go-moose
- Platform
- Developers
- Berkeley Bioinformatics Open-Source Projects, Lawrence Berkeley National Lab, Berkeley, California, USA.
- GO Consortium.
- Contact
- GO Helpdesk
- License
- Free for academic use
- GO data updates
- not applicable (e.g. because users provide data)
go-moose is intended as a replacement for the aging go-perl and go-db-perl Perl libraries. It is written using the object oriented Moose libraries. It can be used for performing a number of analyses on GO data, including the remapping of GO annotations to a selected subset of GO terms.
- software library
- slimmer-type tool
- other analysis
Tool listing last updated 01 January 2011
go-perl
- Platform
- Developer
- GO Consortium.
- License
- Free for academic use
- GO data updates
- not applicable (e.g. because users provide data)
go-perl is a set of Perl modules for parsing, manipulating and exporting ontologies and annotations. It includes parsers for the OBO and GO gene association file formats. It has a graph-based object model with methods for graph traversal. For more details, see the documentation included with the modules.
go-perl comes bundled with XSL [Extensible Stylesheet Language] transforms (which can also be used independently of Perl, provided you have files in OBO-XML format), as well as scripts that can be used as standalone tools.
Installation should be simple, provided you have some experience with Perl and CPAN; see the INSTALL file for details.
- software library
- slimmer-type tool
Tool listing last updated 10 October 2010
GOSlimViewer
- Platform
- Developer
- AgBase, Mississippi State University, Starkville, Mississippi, USA.
- Contact
- Fiona McCarthy
- Publications
- PMID:17135208
- License
- Free for academic use
- GO data updates
- every three months (or more frequently)
- GO data used
- terms
- definitions and comments
- synonyms
- cross-references
- relationships
- subsets or GO slims
- gene product data
- taxon
- evidence codes
- references
- qualifiers
GOSlimViewer is used to summarize the GO function associated with a data set using prepared GO Slim sets. The input is a tab separated list of gene product IDs and GO IDs.
- ontology or annotation browser
- slimmer-type tool
Tool listing last updated 09 June 2010
QuickGO
- Platform
- Developer
- UniProtKB-GOA, European Bioinformatics Institute, Cambridge, UK.
- Contact
- Tony Sawford
- Publications
- PMID:19744993
- PMID:20157483
- License
- Free for academic use
- GO data updates
- daily
- GO data used
- terms
- definitions and comments
- synonyms
- cross-references
- relationships
- subsets or GO slims
- gene product data
- taxon
- evidence codes
- references
- qualifiers
QuickGO is a web-based tool that allows easy browsing of the Gene Ontology (GO) and all associated electronic and manual GO annotations provided by the GO Consortium annotation groups. QuickGO offers a range of facilities including bulk downloads of GO annotation data which can be extensively filtered by a range of different parameters and GO slim set generation.
- ontology or annotation browser
- ontology or annotation search engine
- ontology or annotation visualization
- database or data warehouse
- slimmer-type tool
Tool listing last updated 21 June 2010
ToppGene Suite
- Platform
- Developer
- Cincinnati Childrens Hospital Medical Center, Cincinnati, Ohio, USA.
- Contact
- Anil Jegga
- Publications
- PMID:19465376
- License
- Free for academic use
- GO data updates
- no fixed update schedule
- GO data used
- terms
- definitions and comments
- synonyms
- cross-references
- relationships
- subsets or GO slims
- gene product data
- taxon
- evidence codes
- references
- qualifiers
ToppGene Suite is a one-stop portal for (i) gene list functional enrichment, (ii) candidate gene prioritization using either functional annotations or network analysis and (iii) identification and prioritization of novel disease candidate genes in the interactome. Functional annotation-based disease candidate gene prioritization uses a fuzzy-based similarity measure to compute the similarity between any two genes based on semantic annotations. The similarity scores from individual features are combined into an overall score using statistical meta-analysis. A P-value of each annotation of a test gene is derived by random sampling of the whole genome.
- database or data warehouse
- slimmer-type tool
- term enrichment
- protein interactions
- functional similarity
- other analysis
- disease gene ranking based on functional annotation similarity
Tool listing last updated 21 January 2011
Blast2GO (B2G)
- Platform
- Developer
- Bioinformatics Department, Centro de Investigacion Principe Felipe, Valencia, Spain.
- Publications
- PMID:16081474
- License
- Free for academic use
Blast2GO (B2G) joins in one universal application similarity search based GO annotation and functional analysis. B2G offers the possibility of direct statistical analysis on gene function information and visualization of relevant functional features on a highlighted GO direct acyclic graph (DAG). Furthermore B2G includes various statistics charts summarizing the results obtained at BLASTing, GO-mapping, annotation and enrichment analysis (Fisher's Exact Test). All analysis process steps are configurable and data import and export are supported at any stage. The application also accepts pre-existing BLAST or annotation files and takes them to subsequent steps. The tool offers a very suitable platform for high throughput functional genomics research in non-model species. B2G is a species-independent, intuitive and interactive desktop application which allows monitoring and comprehending the whole annotation and analysis process supported by additional features like GO Slim integration, evidence code (EC) consideration, a Batch-Mode or GO-Multilevel-Pies.
- ontology or annotation editor
- statistical analysis
- slimmer-type tool
Tool listing submitted before 2009; tool may be unsupported or inactive.
Cluster Enrichment (CLENCH)
- Platform
- Developer
- Stanford Center for Biomedical Informatics Research, Stanford University, California, USA.
- Publications
- PMID:14764555
- License
- Free for academic use
Cluster Enrichment (CLENCH) allows A. thaliana researchers to perform automated retrieval of GO annotations from TAIR and calculate enrichment of GO terms in gene group with respect to a reference set. Before calculating enrichment, CLENCH allows mapping of the returned annotations to arbitrary coarse levels using GO slim term lists (which can be edited by the user) and a local installation of GO.
- statistical analysis
- slimmer-type tool
Tool listing submitted before 2009; tool may be unsupported or inactive.
GO Slim Mapper
- Platform
- Developer
- Saccharomyces Genome Database.
- License
- Free for academic use
The GO Slim Mapper (aka GO Term Mapper) maps the specific, granular GO terms used to annotate a list of budding yeast gene products to corresponding more general parent GO slim terms. Uses the SGD GO Slim sets.
- statistical analysis
- slimmer-type tool
Tool listing submitted before 2009; tool may be unsupported or inactive.
GOHyperGAll
- Platform
- Developer
- University of California, Riverside.
- License
- Free for academic use
To test a sample population of genes for overrepresentation of GO terms, the R/BioC function GOHyperGAll computes for all GO nodes a hypergeometric distribution test and returns the corresponding p-values. A subsequent filter function performs a GO Slim analysis using default or custom GO Slim categories. Basic knowledge about R and BioConductor is required for using this tool.
- statistical analysis
- slimmer-type tool
Tool listing submitted before 2009; tool may be unsupported or inactive.
GOToolBox
- Platform
- Developer
- Developmental Biology Institute of Marseille, France.
- Publications
- PMID:15575967
- License
- Free for academic use
GOToolBox is a series of web-based programs allowing the identification of statistically over- or under-represented terms in a gene dataset relative to a reference gene set; the clustering of functionally related genes within a set; and the retrieval of genes sharing annotations with a query gene. GO annotations can also be constrained to a slim hierarchy or a given level of the ontology and terms can be filtered on evidence codes. Updated monthly with GO and gene association files.
- statistical analysis
- slimmer-type tool
Tool listing submitted before 2009; tool may be unsupported or inactive.