Mercurial > repos > proteore > proteore_go_terms_profiles_comparison
changeset 0:fe80e3b6b5c2 draft default tip
planemo upload commit b8671ffe2e12dc6612b971a3e6e1dc71496aefd0-dirty
author | proteore |
---|---|
date | Fri, 24 Jan 2020 10:34:33 -0500 |
parents | |
children | |
files | GO_prof_comp.R GO_prof_comp.xml test-data/Bred.tsv test-data/GO_profiles_comp_BP.png test-data/GO_profiles_comp_BP.tsv test-data/Muc.tsv test-data/log.txt |
diffstat | 6 files changed, 2010 insertions(+), 0 deletions(-) [+] |
line wrap: on
line diff
--- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/GO_prof_comp.R Fri Jan 24 10:34:33 2020 -0500 @@ -0,0 +1,304 @@ +options(warn=-1) #TURN OFF WARNINGS !!!!!! +suppressMessages(library(clusterProfiler,quietly = TRUE)) +suppressMessages(library(plyr, quietly = TRUE)) +suppressMessages(library(ggplot2, quietly = TRUE)) +suppressMessages(library(DOSE, quietly = TRUE)) + +#return the number of character from the longest description found (from the 10 first) +max_str_length_10_first <- function(vector){ + vector <- as.vector(vector) + nb_description = length(vector) + if (nb_description >= 10){nb_description=10} + return(max(nchar(vector[1:nb_description]))) +} + +str2bool <- function(x){ + if (any(is.element(c("t","true"),tolower(x)))){ + return (TRUE) + }else if (any(is.element(c("f","false"),tolower(x)))){ + return (FALSE) + }else{ + return(NULL) + } +} + +get_args <- function(){ + + ## Collect arguments + args <- commandArgs(TRUE) + + ## Default setting when no arguments passed + if(length(args) < 1) { + args <- c("--help") + } + + ## Help section + if("--help" %in% args) { + cat("Selection and Annotation HPA + Arguments: + --inputtype1: type of input (list of id or filename) + --inputtype2: type of input (list of id or filename) + --input1: input1 + --input2: input2 + --column1: the column number which you would like to apply... + --column2: the column number which you would like to apply... + --header1: true/false if your file contains a header + --header2: true/false if your file contains a header + --ont: ontology to use + --lev: ontology level + --org: organism db package + --list_name1: name of the first list + --list_name2: name of the second list \n") + + q(save="no") + } + + parseArgs <- function(x) strsplit(sub("^--", "", x), "=") + argsDF <- as.data.frame(do.call("rbind", parseArgs(args))) + args <- as.list(as.character(argsDF$V2)) + names(args) <- argsDF$V1 + + return(args) +} + +get_ids=function(inputtype, input, ncol, header) { + + if (inputtype == "text") { + ids = strsplit(input, "[ \t\n]+")[[1]] + } else if (inputtype == "file") { + header=str2bool(header) + ncol=get_cols(ncol) + csv = read.csv(input,header=header, sep="\t", as.is=T) + ids=csv[,ncol] + } + + ids = unlist(strsplit(as.character(ids),";")) + ids = ids[which(!is.na(ids))] + + return(ids) +} + +str2bool <- function(x){ + if (any(is.element(c("t","true"),tolower(x)))){ + return (TRUE) + }else if (any(is.element(c("f","false"),tolower(x)))){ + return (FALSE) + }else{ + return(NULL) + } +} + +check_ids <- function(vector,type) { + uniprot_pattern = "^([OPQ][0-9][A-Z0-9]{3}[0-9]|[A-NR-Z][0-9]([A-Z][A-Z0-9]{2}[0-9]){1,2})$" + entrez_id = "^([0-9]+|[A-Z]{1,2}_[0-9]+|[A-Z]{1,2}_[A-Z]{1,4}[0-9]+)$" + if (type == "entrez") + return(grepl(entrez_id,vector)) + else if (type == "uniprot") { + return(grepl(uniprot_pattern,vector)) + } +} + +#res.cmp@compareClusterResult$Description <- sapply(as.vector(res.cmp@compareClusterResult$Description), function(x) {ifelse(nchar(x)>50, substr(x,1,50),x)},USE.NAMES = FALSE) +fortify.compareClusterResult <- function(res.cmp, showCategory=30, by="geneRatio", split=NULL, includeAll=TRUE) { + clProf.df <- as.data.frame(res.cmp) + .split <- split + ## get top 5 (default) categories of each gene cluster. + if (is.null(showCategory)) { + result <- clProf.df + } else { + Cluster <- NULL # to satisfy codetools + topN <- function(res, showCategory) { + ddply(.data = res, .variables = .(Cluster), .fun = function(df, N) { + if (length(df$Count) > N) { + if (any(colnames(df) == "pvalue")) { + idx <- order(df$pvalue, decreasing=FALSE)[1:N] + } else { + ## for groupGO + idx <- order(df$Count, decreasing=T)[1:N] + } + return(df[idx,]) + } else { + return(df) + } + }, + N=showCategory + ) + } + if (!is.null(.split) && .split %in% colnames(clProf.df)) { + lres <- split(clProf.df, as.character(clProf.df[, .split])) + lres <- lapply(lres, topN, showCategory = showCategory) + result <- do.call('rbind', lres) + } else { + result <- topN(clProf.df, showCategory) + } + } + ID <- NULL + if (includeAll == TRUE) { + result = subset(clProf.df, ID %in% result$ID) + } + ## remove zero count + result$Description <- as.character(result$Description) ## un-factor + GOlevel <- result[,c("ID", "Description")] ## GO ID and Term + GOlevel <- unique(GOlevel) + result <- result[result$Count != 0, ] + result$Description <- factor(result$Description,levels=rev(GOlevel[,2])) + if (by=="rowPercentage") { + Description <- Count <- NULL # to satisfy codetools + result <- ddply(result,.(Description),transform,Percentage = Count/sum(Count),Total = sum(Count)) + ## label GO Description with gene counts. + x <- mdply(result[, c("Description", "Total")], paste, sep=" (") + y <- sapply(x[,3], paste, ")", sep="") + result$Description <- y + + ## restore the original order of GO Description + xx <- result[,c(2,3)] + xx <- unique(xx) + rownames(xx) <- xx[,1] + Termlevel <- xx[as.character(GOlevel[,1]),2] + + ##drop the *Total* column + result <- result[, colnames(result) != "Total"] + result$Description <- factor(result$Description, levels=rev(Termlevel)) + + } else if (by == "count") { + ## nothing + } else if (by == "geneRatio") { ##default + gsize <- as.numeric(sub("/\\d+$", "", as.character(result$GeneRatio))) + gcsize <- as.numeric(sub("^\\d+/", "", as.character(result$GeneRatio))) + result$GeneRatio = gsize/gcsize + cluster <- paste(as.character(result$Cluster),"\n", "(", gcsize, ")", sep="") + lv <- unique(cluster)[order(as.numeric(unique(result$Cluster)))] + result$Cluster <- factor(cluster, levels = lv) + } else { + ## nothing + } + return(result) +} + +##function plotting.clusteProfile from clusterProfiler pkg +plotting.clusterProfile <- function(clProf.reshape.df,x = ~Cluster,type = "dot", colorBy = "p.adjust",by = "geneRatio",title="",font.size=12) { + + Description <- Percentage <- Count <- Cluster <- GeneRatio <- p.adjust <- pvalue <- NULL # to + if (type == "dot") { + if (by == "rowPercentage") { + p <- ggplot(clProf.reshape.df, + aes_(x = x, y = ~Description, size = ~Percentage)) + } else if (by == "count") { + p <- ggplot(clProf.reshape.df, + aes_(x = x, y = ~Description, size = ~Count)) + } else if (by == "geneRatio") { ##DEFAULT + p <- ggplot(clProf.reshape.df, + aes_(x = x, y = ~Description, size = ~GeneRatio)) + } else { + ## nothing here + } + if (any(colnames(clProf.reshape.df) == colorBy)) { + p <- p + + geom_point() + + aes_string(color=colorBy) + + scale_color_continuous(low="red", high="blue", guide=guide_colorbar(reverse=TRUE)) + ## scale_color_gradientn(guide=guide_colorbar(reverse=TRUE), colors = enrichplot:::sig_palette) + } else { + p <- p + geom_point(colour="steelblue") + } + } + + p <- p + xlab("") + ylab("") + ggtitle(title) + + theme_dose(font.size) + + ## theme(axis.text.x = element_text(colour="black", size=font.size, vjust = 1)) + + ## theme(axis.text.y = element_text(colour="black", + ## size=font.size, hjust = 1)) + + ## ggtitle(title)+theme_bw() + ## p <- p + theme(axis.text.x = element_text(angle=angle.axis.x, + ## hjust=hjust.axis.x, + ## vjust=vjust.axis.x)) + + return(p) +} + +make_dotplot<-function(res.cmp,ontology) { + + dfok<-fortify.compareClusterResult(res.cmp) + dfok$Description <- sapply(as.vector(dfok$Description), function(x) {ifelse(nchar(x)>50, substr(x,1,50),x)},USE.NAMES = FALSE) + p<-plotting.clusterProfile(dfok, title="") + + #plot(p, type="dot") # + output_path= paste("GO_profiles_comp_",ontology,".png",sep="") + png(output_path,height = 720, width = 600) + pl <- plot(p, type="dot") + print(pl) + dev.off() +} + +get_cols <-function(input_cols) { + input_cols <- gsub("c","",gsub("C","",gsub(" ","",input_cols))) + if (grepl(":",input_cols)) { + first_col=unlist(strsplit(input_cols,":"))[1] + last_col=unlist(strsplit(input_cols,":"))[2] + cols=first_col:last_col + } else { + cols = as.integer(unlist(strsplit(input_cols,","))) + } + return(cols) +} + +#to check +cmp.GO <- function(l,fun="groupGO",orgdb, ontology, level=3, readable=TRUE) { + cmpGO<-compareCluster(geneClusters = l, + fun=fun, + OrgDb = orgdb, + ont=ontology, + level=level, + readable=TRUE) + + return(cmpGO) +} + +check_ids <- function(vector,type) { + uniprot_pattern = "^([OPQ][0-9][A-Z0-9]{3}[0-9]|[A-NR-Z][0-9]([A-Z][A-Z0-9]{2}[0-9]){1,2})$" + entrez_id = "^([0-9]+|[A-Z]{1,2}_[0-9]+|[A-Z]{1,2}_[A-Z]{1,4}[0-9]+)$" + if (type == "entrez") + return(grepl(entrez_id,vector)) + else if (type == "uniprot") { + return(grepl(uniprot_pattern,vector)) + } +} + +main = function() { + + #to get the args of the command line + args=get_args() + + + ids1<-get_ids(args$inputtype1, args$input1, args$column1, args$header1) + ids2<-get_ids(args$inputtype2, args$input2, args$column2, args$header2) + ont = strsplit(args$ont, ",")[[1]] + lev=as.integer(args$lev) + org=args$org + + #load annot package + suppressMessages(library(args$org, character.only = TRUE, quietly = TRUE)) + + # Extract OrgDb + if (args$org=="org.Hs.eg.db") { + orgdb<-org.Hs.eg.db + } else if (args$org=="org.Mm.eg.db") { + orgdb<-org.Mm.eg.db + } else if (args$org=="org.Rn.eg.db") { + orgdb<-org.Rn.eg.db + } + + for(ontology in ont) { + liste = list("l1"=ids1,"l2"=ids2) + names(liste) = c(args$list_name1,args$list_name2) + res.cmp<-cmp.GO(l=liste,fun="groupGO",orgdb, ontology, level=lev, readable=TRUE) + make_dotplot(res.cmp,ontology) + output_path = paste("GO_profiles_comp_",ontology,".tsv",sep="") + write.table(res.cmp@compareClusterResult, output_path, sep="\t", row.names=F, quote=F) + } + +} #end main + +main() +
--- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/GO_prof_comp.xml Fri Jan 24 10:34:33 2020 -0500 @@ -0,0 +1,247 @@ +<tool id="go_terms_profiles_comparison" name="Classification and enrichment analysis" version="2020.01.24"> + <description>(Human, Mouse, Rat)[clusterProfiler]</description> + <requirements> + <requirement type="package">R</requirement> + <requirement type="package" version="3.8.2">bioconductor-org.hs.eg.db</requirement> + <requirement type="package" version="3.8.2">bioconductor-org.mm.eg.db</requirement> + <requirement type="package" version="3.8.2">bioconductor-org.rn.eg.db</requirement> + <requirement type="package" version="3.10.2">bioconductor-dose</requirement> + <requirement type="package" version="3.12.0">bioconductor-clusterprofiler</requirement> + </requirements> + <command detect_errors="exit_code"><![CDATA[ + + Rscript $__tool_directory__/GO_prof_comp.R + --inputtype1="$input1.ids1" + --inputtype2="$input2.ids2" + + #if $input1.ids1 == "text" + --input1="$input1.txt1" + #else if $input1.ids1 == "file" + --input1="$input1.file1" + --header1="$input1.header1" + --column1="$input1.ncol1" + #end if + + --list_name1="$list_name1" + + #if $input2.ids2 == "text" + --input2="$input2.txt2" + #else if $input2.ids2 == "file" + --input2="$input2.file2" + --header2="$input2.header2" + --column2="$input2.ncol2" + #end if + + --list_name2="$list_name2" + --org="$species" + --ont="$ontology" + --lev="$level" + + > $log + + ]]></command> + <inputs> + <conditional name="input1" > + <param name="ids1" type="select" label="Enter your Gene ID list" help="Copy/paste or from a file (e.g. table)" > + <option value="text">Copy/paste your IDs</option> + <option value="file" selected="true">Input file containing your IDs</option> + </param> + <when value="text" > + <param name="txt1" type="text" label="Copy/paste your identifiers" help='IDs must be separated by spaces into the form field, for example: 2810 7534' > + <sanitizer> + <valid initial="string.printable"> + <remove value="'"/> + </valid> + <mapping initial="none"> + <add source="'" target="__sq__"/> + </mapping> + </sanitizer> + </param> + </when> + <when value="file" > + <param name="file1" type="data" format="txt,tabular" label="Choose a file that contains your list of IDs" help="" /> + <param name="header1" type="boolean" checked="true" truevalue="true" falsevalue="false" label="Does file contain header?" /> + <param name="ncol1" type="text" value="c1" label="Column number of IDs" help='For example, fill in "c1" if it is the first column, "c2" if it is the second column and so on'> + <validator type="regex" message="Please enter a column number, for example: 'c1' for the first column">[c]{0,1}[0-9]+</validator> + </param> + </when> + </conditional> + <param name="list_name1" type="text" label="name of your first ids list" value="list1" optional="false"> + <sanitizer> + <valid initial="string.printable"> + <remove value="'"/> + </valid> + <mapping initial="none"> + <add source="'" target="__sq__"/> + </mapping> + </sanitizer> + <validator type="regex" message="Please enter a list name">[a-zA-Z0-9._-]+</validator> + </param> + <conditional name="input2" > + <param name="ids2" type="select" label="Enter your Gene ID list" help="Copy/paste or from a file (e.g. table)" > + <option value="text">Copy/paste your IDs</option> + <option value="file" selected="true">Input file containing your IDs</option> + </param> + <when value="text" > + <param name="txt2" type="text" label="Copy/paste your identifiers" help='IDs must be separated by spaces into the form field, for example: 2810 7534' > + <sanitizer> + <valid initial="string.printable"> + <remove value="'"/> + </valid> + <mapping initial="none"> + <add source="'" target="__sq__"/> + </mapping> + </sanitizer> + </param> + </when> + <when value="file" > + <param name="file2" type="data" format="txt,tabular" label="Choose a file that contains your list of IDs" help="" /> + <param name="header2" type="boolean" checked="true" truevalue="true" falsevalue="false" label="Does file contain header?" /> + <param name="ncol2" type="text" value="c1" label="Column number of IDs" help='For example, fill in "c1" if it is the first column, "c2" if it is the second column and so on'> + <validator type="regex" message="Please enter a column number, for example: 'c1' for the first column">[c]{0,1}[0-9]+</validator> + </param> + </when> + </conditional> + <param name="list_name2" type="text" label="name of your second ids list" value="list2"> + <sanitizer> + <valid initial="string.printable"> + <remove value="'"/> + </valid> + <mapping initial="none"> + <add source="'" target="__sq__"/> + </mapping> + </sanitizer> + <validator type="regex" message="Please enter a list name">[a-zA-Z0-9._-]+</validator> + </param> + <param name="species" type="select" label="Species" > + <option value="org.Hs.eg.db">Human (Homo sapiens) </option> + <option value="org.Mm.eg.db">Mouse (Mus musculus) </option> + <option value="org.Rn.eg.db">Rat (Rattus norvegicus)</option> + </param> + <param name="ontology" type="select" display="checkboxes" multiple="true" label="Select GO terms category" optional="false" > + <option value="CC">Cellular Component</option> + <option value="BP">Biological Process</option> + <option value="MF">Molecular Function</option> + </param> + <param name="level" type="select" label="Ontology level (the higher this number, the deeper the GO level)"> + <option value="1">1</option> + <option value="2" >2</option> + <option value="3" selected="True">3</option> + <option value="4">4</option> + <option value="5">5</option> + </param> + </inputs> + <outputs> + <data name="log" format="txt" label="GO terms profiles comparison" /> + <collection type="list" label="GO terms profiles comparison files" name="text_output"> + <discover_datasets pattern="(?P<designation>.+\.tsv)" ext="tsv"/> + </collection> + <collection type="list" label="GO terms profiles diagram outputs" name="graph_output" > + <discover_datasets pattern="(?P<designation>.+.png)" ext="png" /> + </collection> + </outputs> + <tests> + <test> + <conditional name="input1"> + <param name="ids1" value="file"/> + <param name="file1" value="Bred.tsv"/> + <param name="header1" value="true"/> + <param name="ncol1" value="c1"/> + </conditional> + <conditional name="input2"> + <param name="ids2" value="file"/> + <param name="file2" value="Muc.tsv"/> + <param name="header2" value="true"/> + <param name="ncol2" value="c1"/> + </conditional> + <param name="list_name1" value="Bred"/> + <param name="list_name2" value="Muc"/> + <param name="species" value="org.Hs.eg.db"/> + <param name="ontology" value="BP"/> + <param name="level" value="3"/> + <output name="log" file="log.txt" /> + <output_collection name="text_output"> + <element name="GO_profiles_comp_BP.tsv" file="GO_profiles_comp_BP.tsv" ftype="tsv"/> + </output_collection> + <output_collection name="graph_output"> + <element name="GO_profiles_comp_BP.png" file="GO_profiles_comp_BP.png" ftype="png"/> + </output_collection> + </test> + </tests> + <help><![CDATA[ + +**Description** + +This tool is based on R package clusterProfiler and allows to perform GO terms classification and enrichment analyses on gene/protein sets (e.g. given a set of genes that are up-regulated under certain conditions, an enrichment analysis will find which GO terms are over-represented (or under-represented) using annotations for that gene/protein set). + +Given a list of IDs, this tool: + +(i) performs gene classification based on GO distribution at a specific level, + +(ii) calculates GO categories enrichment (over- or under-representation) for the IDs of the input list, compared to a background. User has the possibility to use background corresponding to the whole organism or to a user-defined list. In this latter case, we recommand to use the "Build tissue-specific expression dataset" ProteoRE tool to create this list according to your need. + +----- + +**Input** + +Two modes are allowed: either by supplying a tabular file (.csv, .tsv, .txt, .tab) including your IDs (identifiers) or by copy/pasting your IDs (separated by a space). + +"Select type/source of IDs": only entrez gene ID (e.g : 4151, 7412) or Uniprot accession number (e.g. P31946) are allowed. If your list is not in this form, please use the ID_Converter tool of ProteoRE. + +----- + +**Parameters** + +"Species": the three supported species are Homo sapiens, Mus musculus and Rattus norvegicus + +"Perform GO categories representation analysis?": classify genes based on their projection at a specific level of the GO corpus (see parameter below), and provides functions (set to "Yes") + +"Ontology level (the higher this number, the deeper the GO level)": correspond to the level of GO hierarchy (from 1 to 3) (set to level "2" by default). In general the higher the level, the more semantically specific the term is. + +"Perform GO categories enrichment analysis?": calculate enrichment test for GO terms based on hypergeometric distribution (set to "Yes") + +"P-value cut off": P-value threshold value for the declaration of significance (default is < 0.01) + +"Q-value cut off": to prevent high false discovery rate (FDR) in multiple testing, Q-values (adjusted P-values) are estimated for FDR control. (default is < 0.05) + +"Define your own background IDs?": by default the whole genome/proteome is used as a reference background to compute the enrichment. As this reference set should normally only include genes/proteins that were monitored during your analysis, this option allows to provide your own background; this could be for instance, the total number of genes/proteins expressed in the tissue/sample under study. + +If you want to use your own background, click on the "Yes" button. Your gene/protein set must be a list of Entrez gene ID or Uniprot accession number (otherwise, use the ID-Converter tool of ProteoRE). Select the file containing your list of ID (as background), then specify the column number which contains IDs and the type of IDs (gene Entrez or Uniprot Accession number) as requested. + +Of note: for Human species, you can build your own background by using the "Build tissue-specific expression dataset" tool of ProteoRE. + +----- + +**Output** + +Diagram output: graphical output in the form of bar-plot or dot-plot (png, jpeg or pdf format), one figure for each GO category. +Text tables: with the following information GO category description (e.g.BP.Description), GO term identifier (e.g. BP.GOID) and GO term frequency (e.g. BP.Frequency)d graphics representing the repartition and/or enrichment of GO categories. One table and one graphic will be produced for each GO catagory. + +----- + +**Authors** +G Yu, LG Wang, Y Han, QY He. clusterProfiler: an R package for comparing biological themes among gene clusters. +OMICS: A Journal of Integrative Biology 2012, 16(5):284-287. doi:[10.1089/omi.2011.0118](http://dx.doi.org/10.1089/omi.2011.0118) + +User manual / Documentation of the clusterProfiler R package (functions and parameters): +https://bioconductor.org/packages/3.7/bioc/vignettes/clusterProfiler/inst/doc/clusterProfiler.html + +----- + +.. class:: infomark + +**Galaxy integration** + +Florence Combes, Yves Vandenbrouck - CEA, INSERM, CNRS, Grenoble-Alpes University, BIG Institute, FR + +Sandra Dérozier, Olivier Rué, Christophe Caron, Valentin Loux - INRA, Paris-Saclay University, MAIAGE Unit, Migale Bioinformatics platform, FR + +This work has been partially funded through the French National Agency for Research (ANR) IFB project. + +Contact support@proteore.org for any questions or concerns about the Galaxy implementation of this tool. + + + ]]></help> + <citations> + </citations> +</tool>
--- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/Bred.tsv Fri Jan 24 10:34:33 2020 -0500 @@ -0,0 +1,121 @@ +GeneID +2810 +7534 +60 +173 +5004 +1 +2 +301 +302 +306 +308 +462 +335 +348 +383 +567 +642 +810 +1509 +1356 +89953 +1191 +1072 +714 +717 +718 +720;721 +100293534;721 +1041 +6699 +1472 +1755 +1828 +147409 +10577 +NA +NA +2171 +388698 +NA +3959 +2597 +5837 +3240 +3320 +3326 +3043 +3263 +NA +3273 +3017;8343;8339;8347;8346;8344 +8361;8360;8363;8362;8365;8364;8367;8366;8368;8359;8370;8294;554313;121504 +388697 +3383 +NA +NA +NA +NA +NA +NA +NA +NA +NA +3543 +NA +NA +NA +NA +3512 +3697 +12 +5265 +2335 +2934 +2638 +NA +3700 +5317 +1832 +4057 +972 +3933 +3939 +4069 +4360 +NA +NA +NA +1667;728358 +3934 +5116 +157310 +710 +5284 +5216 +5304 +11272 +259 +6279 +7053 +2147 +653509 +6440 +NA +NA +NA +NA +NA +7018 +89777 +213 +NA +6706 +6707 +10568 +7295 +7276 +7280 +563 +124220
--- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/GO_profiles_comp_BP.tsv Fri Jan 24 10:34:33 2020 -0500 @@ -0,0 +1,1171 @@ +Cluster ID Description Count GeneRatio geneID +Bred GO:0019953 sexual reproduction 0 0/113 +Bred GO:0019954 asexual reproduction 0 0/113 +Bred GO:0022414 reproductive process 6 6/113 ANXA1/ARG1/DSG1/HSP90AB1/ICAM1/AMBP +Bred GO:0032504 multicellular organism reproduction 4 4/113 ANXA1/ARG1/DSG1/ICAM1 +Bred GO:0032505 reproduction of a single-celled organism 0 0/113 +Bred GO:0061887 reproduction of symbiont in host 0 0/113 +Bred GO:0055114 oxidation-reduction process 6 6/113 APOA1/CP/GAPDH/PYGM/LDHA/TXN +Bred GO:0006807 nitrogen compound metabolic process 86 86/113 SFN/YWHAZ/ACTB/A2M/ANXA1/ANXA2/ANXA3/SERPINC1/APOA1/APOE/ARG1/B2M/BLMH/CTSD/CP/CLU/CFL1/C1QC/C2/C3/C4A/C4B/C4B/SPRR1B/CST4/DMBT1/DSG4/FABP5/GAPDH/HSP90AA1/HSP90AB1/HBB/HPX/HRG/HIST1H2BD/HIST1H2BF/HIST1H2BG/HIST1H2BC/HIST1H2BI/HIST1H2BE/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/IGLL1/ITIH1/SERPINA3/SERPINA1/FN1/GSN/ITIH4/PKP1/DSP/LTF/CD74/LCN1/LDHA/LYZ/SERPING1/PFN1/PIP/AMBP/S100A8/TGM3/F2/SFTPA1/SFTPC/TF/SERPINB12/ALB/SPRR3/SLC34A2/TXN/TTR/AZGP1 +Bred GO:0009056 catabolic process 21 21/113 YWHAZ/ANXA2/APOA1/APOE/ARG1/BLMH/CTSD/CLU/FABP5/GAPDH/PYGM/HP/HSP90AA1/HSP90AB1/HBB/PKP1/LDHA/LYZ/AMBP/S100A8/SERPINB12 +Bred GO:0009058 biosynthetic process 34 34/113 ANXA1/ANXA3/APOA1/APOE/ARG1/CLU/C3/DSG4/FABP5/GAPDH/HSP90AA1/HSP90AB1/HBB/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/LTF/CD74/PFN1/S100A8/F2/TXN +Bred GO:0009892 negative regulation of metabolic process 42 42/113 SFN/YWHAZ/A2M/ANXA2/SERPINC1/APOE/CLU/C3/C4A/C4B/C4B/CST4/GAPDH/HP/HSP90AB1/HRG/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ITIH1/SERPINA3/SERPINA1/ITIH4/PKP1/LTF/LCN1/SERPING1/AMBP/F2/SERPINB12/TXN +Bred GO:0009893 positive regulation of metabolic process 39 39/113 ACTB/ANXA1/ANXA2/ANXA3/APOA1/APOE/CLU/C3/HSP90AA1/HSP90AB1/HBB/HPX/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/JCHAIN/FN1/GSN/PKP1/LTF/CD74/LCN2/PFN1/PIP/S100A8/F2/TXN +Bred GO:0018933 nicotine metabolic process 0 0/113 +Bred GO:0019222 regulation of metabolic process 62 62/113 SFN/YWHAZ/ACTB/A2M/ANXA1/ANXA2/ANXA3/SERPINC1/APOA1/APOE/CLU/C1QC/C2/C3/C4A/C4B/C4B/CST4/DSG4/NPC2/GAPDH/HP/HSP90AA1/HSP90AB1/HBB/HPX/HRG/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/JCHAIN/ITIH1/SERPINA3/SERPINA1/FN1/GSN/ITIH4/PKP1/LTF/CD74/LCN1/LCN2/SERPING1/PFN1/PIP/AMBP/S100A8/F2/SERPINB12/TXN +Bred GO:0019694 alkanesulfonate metabolic process 0 0/113 +Bred GO:0019748 secondary metabolic process 0 0/113 +Bred GO:0032259 methylation 0 0/113 +Bred GO:0042440 pigment metabolic process 2 2/113 HPX/AMBP +Bred GO:0042445 hormone metabolic process 1 1/113 TTR +Bred GO:0044033 multi-organism metabolic process 1 1/113 ANXA2 +Bred GO:0044236 multicellular organism metabolic process 3 3/113 ARG1/CTSD/F2 +Bred GO:0044237 cellular metabolic process 85 85/113 SFN/YWHAZ/ACTB/A2M/ANXA1/ANXA2/ANXA3/SERPINC1/APOA1/APOE/ARG1/B2M/BLMH/CTSD/CP/CLU/CFL1/C3/C4A/C4B/C4B/SPRR1B/CST4/DMBT1/DSG4/NPC2/FABP5/GAPDH/PYGM/HP/HSP90AA1/HSP90AB1/HBB/HPX/HRG/HIST1H2BD/HIST1H2BF/HIST1H2BG/HIST1H2BC/HIST1H2BI/HIST1H2BE/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/ITIH1/SERPINA3/SERPINA1/FN1/GSN/ITIH4/PKP1/DSP/LTF/CD74/LCN1/LDHA/LYZ/SERPING1/PFN1/AMBP/S100A8/TGM3/F2/SFTPA1/SFTPC/TF/SERPINB12/ALB/SPRR3/SLC34A2/TXN/TTR/AZGP1 +Bred GO:0044238 primary metabolic process 88 88/113 SFN/YWHAZ/ACTB/A2M/ANXA1/ANXA2/ANXA3/SERPINC1/APOA1/APOE/ARG1/B2M/BLMH/CTSD/CP/CLU/CFL1/C1QC/C2/C3/C4A/C4B/C4B/SPRR1B/CST4/DMBT1/DSG4/NPC2/FABP5/GAPDH/PYGM/HSP90AA1/HSP90AB1/HPX/HRG/HIST1H2BD/HIST1H2BF/HIST1H2BG/HIST1H2BC/HIST1H2BI/HIST1H2BE/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/IGLL1/ITIH1/SERPINA3/SERPINA1/FN1/GSN/GC/ITIH4/PKP1/DSP/LTF/CD74/LCN1/LDHA/LYZ/SERPING1/PFN1/PIP/AMBP/S100A8/TGM3/F2/SFTPA1/SFTPC/TF/SERPINB12/ALB/SPRR3/SLC34A2/TXN/TTR/AZGP1 +Bred GO:0044281 small molecule metabolic process 16 16/113 ANXA1/APOA1/APOE/ARG1/BLMH/C3/NPC2/FABP5/GAPDH/ITIH1/GC/ITIH4/CD74/LDHA/TXN/TTR +Bred GO:0045730 respiratory burst 1 1/113 JCHAIN +Bred GO:0070085 glycosylation 0 0/113 +Bred GO:0070988 demethylation 0 0/113 +Bred GO:0071704 organic substance metabolic process 89 89/113 SFN/YWHAZ/ACTB/A2M/ANXA1/ANXA2/ANXA3/SERPINC1/APOA1/APOE/ARG1/B2M/BLMH/CTSD/CP/CLU/CFL1/C1QC/C2/C3/C4A/C4B/C4B/SPRR1B/CST4/DMBT1/DSG4/NPC2/FABP5/GAPDH/PYGM/HSP90AA1/HSP90AB1/HPX/HRG/HIST1H2BD/HIST1H2BF/HIST1H2BG/HIST1H2BC/HIST1H2BI/HIST1H2BE/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/IGLL1/ITIH1/SERPINA3/SERPINA1/FN1/GSN/GC/ITIH4/PKP1/DSP/LTF/CD74/LCN1/LDHA/LYZ/LCN2/SERPING1/PFN1/PIP/AMBP/S100A8/TGM3/F2/SFTPA1/SFTPC/TF/SERPINB12/ALB/SPRR3/SLC34A2/TXN/TTR/AZGP1 +Bred GO:1900872 pentadec-1-ene metabolic process 0 0/113 +Bred GO:1901049 atropine metabolic process 0 0/113 +Bred GO:1901275 tartrate metabolic process 0 0/113 +Bred GO:1901902 tyrocidine metabolic process 0 0/113 +Bred GO:1902421 hydrogen metabolic process 0 0/113 +Bred GO:0001909 leukocyte mediated cytotoxicity 4 4/113 ARG1/B2M/ICAM1/F2 +Bred GO:0031341 regulation of cell killing 5 5/113 ARG1/B2M/GAPDH/HSP90AB1/ICAM1 +Bred GO:0031342 negative regulation of cell killing 1 1/113 HSP90AB1 +Bred GO:0031343 positive regulation of cell killing 3 3/113 ARG1/B2M/GAPDH +Bred GO:0031640 killing of cells of other organism 9 9/113 ARG1/GAPDH/HRG/LTF/LYZ/DEFA1/DEFA1B/F2/ALB +Bred GO:0097278 complement-dependent cytotoxicity 1 1/113 HSP90AB1 +Bred GO:0001776 leukocyte homeostasis 2 2/113 ANXA1/CD74 +Bred GO:0002200 somatic diversification of immune receptors 0 0/113 +Bred GO:0002252 immune effector process 49 49/113 ACTB/ORM1/A1BG/A2M/ANXA1/ANXA2/ANXA3/APOA1/ARG1/B2M/CTSD/CLU/C1QC/C2/C3/C4A/C4B/C4B/DMBT1/DSG1/NPC2/FABP5/FLG2/HP/HSP90AA1/HSP90AB1/HBB/HPX/HRNR/ICAM1/IGLL1/SERPINA3/SERPINA1/GSN/PKP1/DSP/LTF/CD74/LYZ/DEFA1/DEFA1B/LCN2/SERPING1/PIGR/S100A8/F2/SFTPA1/SERPINB12/TTR +Bred GO:0002253 activation of immune response 18 18/113 ACTB/A2M/CLU/C1QC/C2/C3/C4A/C4B/C4B/DMBT1/HSP90AA1/HSP90AB1/IGLL1/LTF/SERPING1/S100A8/F2/SFTPA1 +Bred GO:0002262 myeloid cell homeostasis 2 2/113 ANXA1/B2M +Bred GO:0002339 B cell selection 0 0/113 +Bred GO:0002404 antigen sampling in mucosal-associated lymphoid tissue 0 0/113 +Bred GO:0002440 production of molecular mediator of immune response 5 5/113 APOA1/ARG1/B2M/HPX/CD74 +Bred GO:0002507 tolerance induction 0 0/113 +Bred GO:0002520 immune system development 21 21/113 ANXA1/ANXA2/B2M/C1QC/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/LTF/CD74/SERPINB12 +Bred GO:0002682 regulation of immune system process 45 45/113 ACTB/ORM1/A2M/ANXA1/APOA1/ARG1/B2M/CLU/C1QC/C2/C3/C4A/C4B/C4B/DMBT1/HSP90AA1/HSP90AB1/HPX/HRG/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/IGLL1/GSN/LTF/CD74/SERPING1/PIGR/PIP/AMBP/S100A8/F2/SFTPA1 +Bred GO:0002683 negative regulation of immune system process 23 23/113 A2M/ANXA1/APOA1/ARG1/C1QC/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/LTF/CD74/SERPING1/AMBP +Bred GO:0002684 positive regulation of immune system process 25 25/113 ACTB/A2M/ANXA1/ARG1/B2M/CLU/C1QC/C2/C3/C4A/C4B/C4B/DMBT1/HSP90AA1/HSP90AB1/HPX/HRG/ICAM1/IGLL1/LTF/CD74/SERPING1/S100A8/F2/SFTPA1 +Bred GO:0006955 immune response 60 60/113 ACTB/ORM1/A1BG/A2M/ANXA1/ANXA2/ANXA3/SERPINC1/APOA1/ARG1/B2M/CTSD/CLU/C1QC/C2/C3/C4A/C4B/C4B/DMBT1/DSG1/NPC2/FABP5/FLG2/GAPDH/HP/HSP90AA1/HSP90AB1/HBB/HPX/HRG/HIST1H2BF/HIST1H2BG/HIST1H2BC/HIST1H2BI/HIST1H2BE/HRNR/ICAM1/IGLL1/JCHAIN/SERPINA3/SERPINA1/GSN/PKP1/DSP/LTF/CD74/LYZ/MRC1/DEFA1/DEFA1B/LCN2/SERPING1/PIGR/AMBP/S100A8/F2/SFTPA1/SERPINB12/TTR +Bred GO:0019882 antigen processing and presentation 4 4/113 B2M/CTSD/ICAM1/CD74 +Bred GO:0031294 lymphocyte costimulation 0 0/113 +Bred GO:0035172 hemocyte proliferation 0 0/113 +Bred GO:0042386 hemocyte differentiation 0 0/113 +Bred GO:0045058 T cell selection 1 1/113 CD74 +Bred GO:0045321 leukocyte activation 36 36/113 ORM1/A1BG/ANXA1/ANXA2/ANXA3/ARG1/B2M/CTSD/CLU/C3/DSG1/NPC2/FABP5/FLG2/HP/HSP90AA1/HSP90AB1/HBB/HRNR/ICAM1/IGLL1/SERPINA3/SERPINA1/GSN/PKP1/DSP/LTF/CD74/LYZ/DEFA1/DEFA1B/LCN2/PIGR/S100A8/SERPINB12/TTR +Bred GO:0050900 leukocyte migration 10 10/113 ANXA1/ICAM1/IGLL1/JCHAIN/FN1/CD74/DEFA1/DEFA1B/S100A8/F2 +Bred GO:0090713 immunological memory process 0 0/113 +Bred GO:0006792 regulation of sulfur utilization 0 0/113 +Bred GO:0045882 negative regulation of sulfur utilization 0 0/113 +Bred GO:0045883 positive regulation of sulfur utilization 0 0/113 +Bred GO:0006795 regulation of phosphorus utilization 0 0/113 +Bred GO:0045942 negative regulation of phosphorus utilization 0 0/113 +Bred GO:0045949 positive regulation of phosphorus utilization 0 0/113 +Bred GO:0001545 primary ovarian follicle growth 0 0/113 +Bred GO:0001546 preantral ovarian follicle growth 0 0/113 +Bred GO:0001550 ovarian cumulus expansion 0 0/113 +Bred GO:0016049 cell growth 6 6/113 SFN/APOE/HRG/FN1/S100A8/F2 +Bred GO:0007117 budding cell bud growth 0 0/113 +Bred GO:0030447 filamentous growth 0 0/113 +Bred GO:0040008 regulation of growth 6 6/113 SFN/APOE/HRG/FN1/S100A8/F2 +Bred GO:0042702 uterine wall growth 0 0/113 +Bred GO:0044110 growth involved in symbiotic interaction 0 0/113 +Bred GO:0045926 negative regulation of growth 1 1/113 HRG +Bred GO:0045927 positive regulation of growth 4 4/113 SFN/FN1/S100A8/F2 +Bred GO:0048589 developmental growth 4 4/113 ANXA1/APOE/FN1/GSN +Bred GO:0080189 primary growth 0 0/113 +Bred GO:0080190 lateral growth 0 0/113 +Bred GO:0002209 behavioral defense response 1 1/113 APOE +Bred GO:0002210 behavioral response to wounding 0 0/113 +Bred GO:0007611 learning or memory 1 1/113 APOE +Bred GO:0007622 rhythmic behavior 0 0/113 +Bred GO:0007625 grooming behavior 0 0/113 +Bred GO:0007626 locomotory behavior 1 1/113 APOE +Bred GO:0030537 larval behavior 0 0/113 +Bred GO:0007631 feeding behavior 0 0/113 +Bred GO:0007632 visual behavior 0 0/113 +Bred GO:0007635 chemosensory behavior 0 0/113 +Bred GO:0007638 mechanosensory behavior 0 0/113 +Bred GO:0030534 adult behavior 0 0/113 +Bred GO:0019098 reproductive behavior 0 0/113 +Bred GO:0032537 host-seeking behavior 0 0/113 +Bred GO:0035187 hatching behavior 0 0/113 +Bred GO:0035640 exploration behavior 1 1/113 APOE +Bred GO:0040040 thermosensory behavior 0 0/113 +Bred GO:0042630 behavioral response to water deprivation 0 0/113 +Bred GO:0048266 behavioral response to pain 0 0/113 +Bred GO:0048520 positive regulation of behavior 0 0/113 +Bred GO:0048521 negative regulation of behavior 0 0/113 +Bred GO:0050795 regulation of behavior 1 1/113 APOE +Bred GO:0051705 multi-organism behavior 0 0/113 +Bred GO:0051780 behavioral response to nutrient 0 0/113 +Bred GO:0051867 general adaptation syndrome, behavioral process 0 0/113 +Bred GO:0060273 crying behavior 0 0/113 +Bred GO:0060756 foraging behavior 0 0/113 +Bred GO:0061744 motor behavior 0 0/113 +Bred GO:0071625 vocalization behavior 0 0/113 +Bred GO:0001833 inner cell mass cell proliferation 0 0/113 +Bred GO:0001834 trophectodermal cell proliferation 0 0/113 +Bred GO:0002174 mammary stem cell proliferation 0 0/113 +Bred GO:0002941 synoviocyte proliferation 0 0/113 +Bred GO:0003419 growth plate cartilage chondrocyte proliferation 0 0/113 +Bred GO:0008284 positive regulation of cell proliferation 7 7/113 ANXA1/ANXA2/ARG1/FN1/LTF/CD74/F2 +Bred GO:0008285 negative regulation of cell proliferation 5 5/113 SFN/APOE/ARG1/HRG/AZGP1 +Bred GO:0010463 mesenchymal cell proliferation 0 0/113 +Bred GO:0014009 glial cell proliferation 1 1/113 CLU +Bred GO:0033002 muscle cell proliferation 0 0/113 +Bred GO:0033687 osteoblast proliferation 1 1/113 LTF +Bred GO:0035726 common myeloid progenitor cell proliferation 0 0/113 +Bred GO:0035736 cell proliferation involved in compound eye morphogenesis 0 0/113 +Bred GO:0035988 chondrocyte proliferation 1 1/113 LTF +Bred GO:0036093 germ cell proliferation 0 0/113 +Bred GO:0042127 regulation of cell proliferation 11 11/113 SFN/ANXA1/ANXA2/APOE/ARG1/HRG/FN1/LTF/CD74/F2/AZGP1 +Bred GO:0044340 canonical Wnt signaling pathway involved in regulation of cell proliferation 0 0/113 +Bred GO:0048134 germ-line cyst formation 0 0/113 +Bred GO:0048144 fibroblast proliferation 3 3/113 ANXA2/FN1/CD74 +Bred GO:0050673 epithelial cell proliferation 4 4/113 SFN/APOA1/APOE/ARG1 +Bred GO:0051450 myoblast proliferation 0 0/113 +Bred GO:0060722 cell proliferation involved in embryonic placenta development 0 0/113 +Bred GO:0061323 cell proliferation involved in heart morphogenesis 0 0/113 +Bred GO:0061351 neural precursor cell proliferation 0 0/113 +Bred GO:0070341 fat cell proliferation 0 0/113 +Bred GO:0070661 leukocyte proliferation 4 4/113 ANXA1/ARG1/CLU/CD74 +Bred GO:0071335 hair follicle cell proliferation 0 0/113 +Bred GO:0071838 cell proliferation in bone marrow 0 0/113 +Bred GO:0072089 stem cell proliferation 0 0/113 +Bred GO:0072111 cell proliferation involved in kidney development 0 0/113 +Bred GO:0090255 cell proliferation involved in imaginal disc-derived wing morphogenesis 0 0/113 +Bred GO:0097360 chorionic trophoblast cell proliferation 0 0/113 +Bred GO:1990654 sebum secreting cell proliferation 0 0/113 +Bred GO:2000793 cell proliferation involved in heart valve development 0 0/113 +Bred GO:0043610 regulation of carbohydrate utilization 0 0/113 +Bred GO:0007059 chromosome segregation 0 0/113 +Bred GO:0007017 microtubule-based process 3 3/113 GAPDH/PCNT/TUBB2A +Bred GO:0000075 cell cycle checkpoint 1 1/113 SFN +Bred GO:0000920 cell separation after cytokinesis 0 0/113 +Bred GO:0001775 cell activation 41 41/113 YWHAZ/ACTB/ORM1/A1BG/ANXA1/ANXA2/ANXA3/APOE/ARG1/B2M/CTSD/CLU/C3/DSG1/NPC2/FABP5/FLG2/HP/HSP90AA1/HSP90AB1/HBB/HRG/HRNR/ICAM1/IGLL1/SERPINA3/SERPINA1/GSN/PKP1/DSP/LTF/CD74/LYZ/DEFA1/DEFA1B/LCN2/PIGR/S100A8/F2/SERPINB12/TTR +Bred GO:0010496 intercellular transport 0 0/113 +Bred GO:0006457 protein folding 5 5/113 B2M/CLU/HSP90AA1/HSP90AB1/CD74 +Bred GO:0007165 signal transduction 41 41/113 SFN/YWHAZ/ACTB/A2M/ANXA1/ANXA2/ANXA5/APOA1/APOE/ARG1/B2M/CLU/CFL1/C3/DMBT1/DSG4/LGALS3BP/HSP90AA1/HSP90AB1/HPX/HRG/ICAM1/IGLL1/FN1/GSN/PKP1/LTF/CD74/MRC1/DEFA1/DEFA1B/LCN2/PCNT/PIGR/PFN1/AMBP/S100A8/F2/SFTPA1/TXN/TTR +Bred GO:0006903 vesicle targeting 1 1/113 SERPINA1 +Bred GO:0006276 plasmid maintenance 0 0/113 +Bred GO:0006928 movement of cell or subcellular component 19 19/113 ACTB/ANXA1/ANXA3/APOA1/APOE/CFL1/HRG/ICAM1/IGLL1/JCHAIN/FN1/DSP/CD74/DEFA1/DEFA1B/PFN1/S100A8/F2/TXN +Bred GO:0006949 syncytium formation 0 0/113 +Bred GO:0007049 cell cycle 6 6/113 SFN/ANXA1/CFL1/HSP90AA1/HSP90AB1/PCNT +Bred GO:0007154 cell communication 43 43/113 SFN/YWHAZ/ACTB/A2M/ANXA1/ANXA2/ANXA5/APOA1/APOE/ARG1/B2M/CLU/CFL1/C3/DMBT1/DSG4/LGALS3BP/HSP90AA1/HSP90AB1/HPX/HRG/ICAM1/IGLL1/FN1/GSN/PKP1/DSP/LTF/CD74/MRC1/DEFA1/DEFA1B/LCN2/PCNT/PIGR/PFN1/AMBP/S100A8/F2/SFTPA1/ALB/TXN/TTR +Bred GO:0007163 establishment or maintenance of cell polarity 2 2/113 CFL1/GSN +Bred GO:0007272 ensheathment of neurons 1 1/113 CLU +Bred GO:0008219 cell death 30 30/113 SFN/YWHAZ/ANXA1/ANXA5/APOE/CLU/CFL1/CDSN/SPRR1B/DSG1/DSG4/GAPDH/HP/HSP90AB1/HBB/HRG/ICAM1/GSN/PKP1/DSP/LTF/CD74/LDHA/LCN2/PIP/S100A8/ALB/SPRR2G/SPRR3/TXN +Bred GO:0008037 cell recognition 1 1/113 IGLL1 +Bred GO:0019835 cytolysis 4 4/113 HRG/LYZ/F2/ALB +Bred GO:0010118 stomatal movement 0 0/113 +Bred GO:0016037 light absorption 0 0/113 +Bred GO:0016043 cellular component organization 63 63/113 SFN/YWHAZ/ACTB/A2M/ANXA1/ANXA2/APOA1/APOE/ARG1/B2M/CLU/CFL1/C2/C3/C4A/C4B/C4B/DSG1/GAPDH/HSP90AA1/HSP90AB1/HBB/HRG/HIST1H2BD/HIST1H2BF/HIST1H2BG/HIST1H2BC/HIST1H2BI/HIST1H2BE/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/HRNR/ICAM1/IGLL1/JCHAIN/SERPINA1/FN1/GSN/PKP1/DSP/CD74/LCN2/PCNT/PFN1/S100A8/TGM3/F2/TF/ALB/TTR/TUBB2A +Bred GO:0016458 gene silencing 14 14/113 HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4 +Bred GO:0019725 cellular homeostasis 11 11/113 APOE/CP/HPX/ICAM1/LTF/LCN2/S100A8/F2/TF/SLC34A2/TXN +Bred GO:0022402 cell cycle process 6 6/113 SFN/ANXA1/CFL1/HSP90AA1/HSP90AB1/PCNT +Bred GO:0022406 membrane docking 3 3/113 HSP90AA1/ICAM1/PCNT +Bred GO:0022412 cellular process involved in reproduction in multicellular organism 0 0/113 +Bred GO:0030029 actin filament-based process 9 9/113 ACTB/ANXA1/APOA1/CFL1/HRG/ICAM1/GSN/DSP/PFN1 +Bred GO:0032196 transposition 0 0/113 +Bred GO:0032940 secretion by cell 44 44/113 ORM1/A1BG/A2M/ANXA1/ANXA2/ANXA3/ANXA5/APOA1/ARG1/B2M/CTSD/CLU/C3/DSG1/NPC2/FABP5/FLG2/LGALS3BP/GAPDH/HP/HSP90AA1/HSP90AB1/HBB/HRG/HRNR/SERPINA3/SERPINA1/FN1/GSN/ITIH4/PKP1/DSP/LTF/LYZ/DEFA1/DEFA1B/LCN2/SERPING1/PIGR/S100A8/TF/SERPINB12/ALB/TTR +Bred GO:0033059 cellular pigmentation 0 0/113 +Bred GO:0034337 RNA folding 0 0/113 +Bred GO:0035212 cell competition in a multicellular organism 0 0/113 +Bred GO:0035638 signal maturation 0 0/113 +Bred GO:0036166 phenotypic switching 0 0/113 +Bred GO:0043335 protein unfolding 1 1/113 HSP90AA1 +Bred GO:0044663 establishment or maintenance of cell type involved in phenotypic switching 0 0/113 +Bred GO:0044764 multi-organism cellular process 4 4/113 HRG/LTF/F2/ALB +Bred GO:0045103 intermediate filament-based process 2 2/113 PKP1/DSP +Bred GO:0048522 positive regulation of cellular process 38 38/113 SFN/YWHAZ/ORM1/ANXA1/ANXA2/ANXA3/APOA1/APOE/ARG1/B2M/CLU/CFL1/C2/C3/C4A/C4B/C4B/GAPDH/HP/HSP90AA1/HSP90AB1/HBB/HPX/HRG/ICAM1/IGLL1/JCHAIN/FN1/GSN/LTF/CD74/LDHA/LCN2/PFN1/S100A8/F2/TF/TXN +Bred GO:0048523 negative regulation of cellular process 58 58/113 SFN/YWHAZ/A2M/ANXA1/ANXA2/ANXA5/SERPINC1/APOA1/APOE/ARG1/B2M/CLU/CFL1/C1QC/C3/C4A/C4B/C4B/CDSN/CST4/GAPDH/HP/HSP90AB1/HRG/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/ITIH1/SERPINA3/SERPINA1/FN1/GSN/ITIH4/PKP1/LTF/CD74/LCN1/SERPING1/PFN1/PIP/AMBP/F2/SERPINB12/ALB/TXN/AZGP1 +Bred GO:0048869 cellular developmental process 44 44/113 SFN/A2M/ANXA1/ANXA2/APOA1/APOE/B2M/CLU/CFL1/C1QC/CDSN/SPRR1B/DMBT1/DSG1/DSG4/HSP90AB1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/HRNR/ICAM1/FN1/GSN/PKP1/DSP/LTF/CD74/S100A8/TGM3/F2/SERPINB12/SPRR2G/SPRR3 +Bred GO:0050794 regulation of cellular process 83 83/113 SFN/YWHAZ/ACTB/ORM1/A2M/ANXA1/ANXA2/ANXA3/ANXA5/SERPINC1/APOA1/APOE/ARG1/B2M/CLU/CFL1/C1QC/C2/C3/C4A/C4B/C4B/CDSN/CST4/DMBT1/DSG4/NPC2/LGALS3BP/GAPDH/HP/HSP90AA1/HSP90AB1/HBB/HPX/HRG/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/IGLL1/JCHAIN/ITIH1/SERPINA3/SERPINA1/FN1/GSN/ITIH4/PKP1/DSP/LTF/CD74/LCN1/LDHA/MRC1/DEFA1/DEFA1B/LCN2/PCNT/SERPING1/PIGR/PFN1/PIP/AMBP/S100A8/F2/SFTPA1/TF/SERPINB12/ALB/TXN/TTR/AZGP1 +Bred GO:0051301 cell division 2 2/113 SFN/CFL1 +Bred GO:0051651 maintenance of location in cell 3 3/113 APOE/GSN/ALB +Bred GO:0051716 cellular response to stimulus 60 60/113 SFN/YWHAZ/ACTB/A2M/ANXA1/ANXA2/ANXA5/APOA1/APOE/ARG1/B2M/CLU/CFL1/C3/DMBT1/DSG4/LGALS3BP/GAPDH/HP/HSP90AA1/HSP90AB1/HBB/HPX/HRG/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/IGLL1/FN1/GSN/PKP1/LTF/CD74/MRC1/DEFA1/DEFA1B/LCN2/PCNT/PIGR/PFN1/AMBP/S100A8/F2/SFTPA1/TF/ALB/TXN/TTR +Bred GO:0060242 contact inhibition 0 0/113 +Bred GO:0060352 cell adhesion molecule production 1 1/113 APOA1 +Bred GO:0061919 process utilizing autophagic mechanism 5 5/113 CTSD/CLU/GAPDH/HSP90AA1/S100A8 +Bred GO:0071554 cell wall organization or biogenesis 1 1/113 LYZ +Bred GO:0071804 cellular potassium ion transport 0 0/113 +Bred GO:0090485 chromosome number maintenance 0 0/113 +Bred GO:0090618 DNA clamp unloading 0 0/113 +Bred GO:0097194 execution phase of apoptosis 0 0/113 +Bred GO:0097528 execution phase of necroptosis 0 0/113 +Bred GO:0140029 exocytic process 0 0/113 +Bred GO:0043609 regulation of carbon utilization 0 0/113 +Bred GO:0006808 regulation of nitrogen utilization 0 0/113 +Bred GO:0019676 ammonia assimilation cycle 0 0/113 +Bred GO:0045847 negative regulation of nitrogen utilization 0 0/113 +Bred GO:0045848 positive regulation of nitrogen utilization 0 0/113 +Bred GO:0000728 gene conversion at mating-type locus, DNA double-strand break formation 0 0/113 +Bred GO:0000734 gene conversion at mating-type locus, DNA repair synthesis 0 0/113 +Bred GO:0000742 karyogamy involved in conjugation with cellular fusion 0 0/113 +Bred GO:0000743 nuclear migration involved in conjugation with cellular fusion 0 0/113 +Bred GO:0000749 response to pheromone involved in conjugation with cellular fusion 0 0/113 +Bred GO:0000751 mitotic cell cycle G1 arrest in response to pheromone 0 0/113 +Bred GO:0000754 adaptation of signaling pathway by response to pheromone involved in conjugation with cellular fusion 0 0/113 +Bred GO:0002077 acrosome matrix dispersal 0 0/113 +Bred GO:0003006 developmental process involved in reproduction 3 3/113 ANXA1/HSP90AB1/ICAM1 +Bred GO:0007299 ovarian follicle cell-cell adhesion 0 0/113 +Bred GO:0007300 ovarian nurse cell to oocyte transport 0 0/113 +Bred GO:0007303 cytoplasmic transport, nurse cell to oocyte 0 0/113 +Bred GO:0007316 pole plasm RNA localization 0 0/113 +Bred GO:0007318 pole plasm protein localization 0 0/113 +Bred GO:0007340 acrosome reaction 0 0/113 +Bred GO:0007343 egg activation 0 0/113 +Bred GO:0007344 pronuclear fusion 0 0/113 +Bred GO:0007534 gene conversion at mating-type locus 0 0/113 +Bred GO:0007543 sex determination, somatic-gonadal interaction 0 0/113 +Bred GO:0007566 embryo implantation 0 0/113 +Bred GO:0009566 fertilization 0 0/113 +Bred GO:0009846 pollen germination 0 0/113 +Bred GO:0009856 pollination 0 0/113 +Bred GO:0009859 pollen hydration 0 0/113 +Bred GO:0009875 pollen-pistil interaction 0 0/113 +Bred GO:0009876 pollen adhesion 0 0/113 +Bred GO:0010069 zygote asymmetric cytokinesis in embryo sac 0 0/113 +Bred GO:0010183 pollen tube guidance 0 0/113 +Bred GO:0010344 seed oilbody biogenesis 0 0/113 +Bred GO:0010588 cotyledon vascular tissue pattern formation 0 0/113 +Bred GO:0010708 heteroduplex formation involved in gene conversion at mating-type locus 0 0/113 +Bred GO:0018985 pronuclear envelope synthesis 0 0/113 +Bred GO:0022413 reproductive process in single-celled organism 0 0/113 +Bred GO:0022602 ovulation cycle process 1 1/113 ICAM1 +Bred GO:0030709 border follicle cell delamination 0 0/113 +Bred GO:0030720 oocyte localization involved in germarium-derived egg chamber formation 0 0/113 +Bred GO:0031292 gene conversion at mating-type locus, DNA double-strand break processing 0 0/113 +Bred GO:0032005 signal transduction involved in conjugation with cellular fusion 0 0/113 +Bred GO:0032219 cell wall macromolecule catabolic process involved in cytogamy 0 0/113 +Bred GO:0032220 plasma membrane fusion involved in cytogamy 0 0/113 +Bred GO:0034624 DNA recombinase assembly involved in gene conversion at mating-type locus 0 0/113 +Bred GO:0034636 strand invasion involved in gene conversion at mating-type locus 0 0/113 +Bred GO:0035036 sperm-egg recognition 0 0/113 +Bred GO:0035037 sperm entry 0 0/113 +Bred GO:0035038 female pronucleus assembly 0 0/113 +Bred GO:0035039 male pronucleus assembly 0 0/113 +Bred GO:0035040 sperm nuclear envelope removal 0 0/113 +Bred GO:0035041 sperm chromatin decondensation 0 0/113 +Bred GO:0035042 fertilization, exchange of chromosomal proteins 0 0/113 +Bred GO:0035044 sperm aster formation 0 0/113 +Bred GO:0035046 pronuclear migration 0 0/113 +Bred GO:0043093 FtsZ-dependent cytokinesis 0 0/113 +Bred GO:0044703 multi-organism reproductive process 3 3/113 ARG1/DSG1/AMBP +Bred GO:0045450 bicoid mRNA localization 0 0/113 +Bred GO:0045729 respiratory burst at fertilization 0 0/113 +Bred GO:0046595 establishment of pole plasm mRNA localization 0 0/113 +Bred GO:0048359 mucilage metabolic process involved in seed coat development 0 0/113 +Bred GO:0048497 maintenance of floral organ identity 0 0/113 +Bred GO:0048544 recognition of pollen 0 0/113 +Bred GO:0048573 photoperiodism, flowering 0 0/113 +Bred GO:0048609 multicellular organismal reproductive process 4 4/113 ANXA1/ARG1/DSG1/ICAM1 +Bred GO:0051037 regulation of transcription involved in meiotic cell cycle 0 0/113 +Bred GO:0051321 meiotic cell cycle 0 0/113 +Bred GO:0051663 oocyte nucleus localization involved in oocyte dorsal/ventral axis specification 0 0/113 +Bred GO:0060011 Sertoli cell proliferation 0 0/113 +Bred GO:0060466 activation of meiosis involved in egg activation 0 0/113 +Bred GO:0060468 prevention of polyspermy 0 0/113 +Bred GO:0060469 positive regulation of transcription involved in egg activation 0 0/113 +Bred GO:0060470 positive regulation of cytosolic calcium ion concentration involved in egg activation 0 0/113 +Bred GO:0060471 cortical granule exocytosis 0 0/113 +Bred GO:0060474 positive regulation of flagellated sperm motility involved in capacitation 0 0/113 +Bred GO:0060475 positive regulation of actin filament polymerization involved in acrosome reaction 0 0/113 +Bred GO:0060476 protein localization involved in acrosome reaction 0 0/113 +Bred GO:0060478 acrosomal vesicle exocytosis 0 0/113 +Bred GO:0060518 cell migration involved in prostatic bud elongation 0 0/113 +Bred GO:0060519 cell adhesion involved in prostatic bud elongation 0 0/113 +Bred GO:0060673 cell-cell signaling involved in placenta development 0 0/113 +Bred GO:0060710 chorio-allantoic fusion 0 0/113 +Bred GO:0060738 epithelial-mesenchymal signaling involved in prostate gland development 0 0/113 +Bred GO:0060739 mesenchymal-epithelial cell signaling involved in prostate gland development 0 0/113 +Bred GO:0060767 epithelial cell proliferation involved in prostate gland development 0 0/113 +Bred GO:0060781 mesenchymal cell proliferation involved in prostate gland development 0 0/113 +Bred GO:0060783 mesenchymal smoothened signaling pathway involved in prostate gland development 0 0/113 +Bred GO:0060858 vesicle-mediated transport involved in floral organ abscission 0 0/113 +Bred GO:0060869 transmembrane receptor protein serine/threonine kinase signaling pathway involved in floral organ abscission 0 0/113 +Bred GO:0060870 cell wall disassembly involved in floral organ abscission 0 0/113 +Bred GO:0061450 trophoblast cell migration 0 0/113 +Bred GO:0061500 gene conversion at mating-type locus, termination of copy-synthesis 0 0/113 +Bred GO:0061883 clathrin-dependent endocytosis involved in vitellogenesis 0 0/113 +Bred GO:0061948 premature acrosome loss 0 0/113 +Bred GO:0070871 cell wall organization involved in conjugation with cellular fusion 0 0/113 +Bred GO:0070872 plasma membrane organization involved in conjugation with cellular fusion 0 0/113 +Bred GO:0071432 peptide mating pheromone maturation involved in conjugation with cellular fusion 0 0/113 +Bred GO:0071508 activation of MAPK activity involved in conjugation with cellular fusion 0 0/113 +Bred GO:0071509 activation of MAPKK activity involved in conjugation with cellular fusion 0 0/113 +Bred GO:0071510 activation of MAPKKK activity involved in conjugation with cellular fusion 0 0/113 +Bred GO:0071511 inactivation of MAPK activity involved in conjugation with cellular fusion 0 0/113 +Bred GO:0071512 MAPK import into nucleus involved in conjugation with cellular fusion 0 0/113 +Bred GO:0071631 mating pheromone secretion involved in conjugation with cellular fusion 0 0/113 +Bred GO:0071833 peptide pheromone export involved in conjugation with cellular fusion 0 0/113 +Bred GO:0072409 detection of stimulus involved in meiotic cell cycle checkpoint 0 0/113 +Bred GO:0090220 chromosome localization to nuclear envelope involved in homologous chromosome segregation 0 0/113 +Bred GO:1902064 regulation of transcription from RNA polymerase II promoter involved in spermatogenesis 0 0/113 +Bred GO:1902397 detection of stimulus involved in meiotic spindle checkpoint 0 0/113 +Bred GO:1902441 protein localization to meiotic spindle pole body 0 0/113 +Bred GO:1903046 meiotic cell cycle process 0 0/113 +Bred GO:2000241 regulation of reproductive process 0 0/113 +Bred GO:2000242 negative regulation of reproductive process 0 0/113 +Bred GO:2000243 positive regulation of reproductive process 0 0/113 +Bred GO:0007155 cell adhesion 20 20/113 ACTB/ANXA1/ANXA2/APOA1/ARG1/CDSN/DSG1/DSG4/LGALS3BP/HBB/HRG/ICAM1/FN1/GSN/PKP1/DSP/CD74/AMBP/S100A8/AZGP1 +Bred GO:0022608 multicellular organism adhesion 0 0/113 +Bred GO:0044406 adhesion of symbiont to host 3 3/113 HSP90AB1/ICAM1/LTF +Bred GO:0090675 intermicrovillar adhesion 0 0/113 +Bred GO:0007267 cell-cell signaling 4 4/113 ANXA1/APOE/PFN1/TXN +Bred GO:0021807 motogenic signaling initiating cell movement in cerebral cortex 0 0/113 +Bred GO:0021837 motogenic signaling involved in postnatal olfactory bulb interneuron migration 0 0/113 +Bred GO:0021838 motogenic signaling involved in interneuron migration from the subpallium to the cortex 0 0/113 +Bred GO:0023051 regulation of signaling 23 23/113 SFN/YWHAZ/A2M/ANXA1/ANXA2/APOA1/APOE/ARG1/CLU/C3/HSP90AB1/HPX/HRG/ICAM1/FN1/GSN/LTF/CD74/AMBP/S100A8/F2/TXN/TTR +Bred GO:0023056 positive regulation of signaling 15 15/113 SFN/YWHAZ/ANXA2/APOA1/APOE/C3/HSP90AB1/HPX/ICAM1/GSN/LTF/CD74/S100A8/F2/TXN +Bred GO:0023057 negative regulation of signaling 9 9/113 APOA1/APOE/ARG1/CLU/HRG/ICAM1/LTF/CD74/AMBP +Bred GO:0035636 multi-organism signaling 0 0/113 +Bred GO:0035426 extracellular matrix-cell signaling 0 0/113 +Bred GO:0035637 multicellular organismal signaling 1 1/113 DSP +Bred GO:0001503 ossification 1 1/113 LTF +Bred GO:0001763 morphogenesis of a branching structure 0 0/113 +Bred GO:0001816 cytokine production 14 14/113 ORM1/ANXA1/APOA1/ARG1/B2M/CLU/C3/GAPDH/HSP90AB1/FN1/LTF/CD74/S100A8/F2 +Bred GO:0002021 response to dietary excess 1 1/113 APOE +Bred GO:0002532 production of molecular mediator involved in inflammatory response 1 1/113 F2 +Bred GO:0003008 system process 15 15/113 APOA1/APOE/CST4/HBB/ICAM1/JCHAIN/SERPINA3/GSN/DSP/LCN1/SERPING1/PIGR/PIP/PRR4/AZGP1 +Bred GO:0003053 circadian regulation of heart rate 0 0/113 +Bred GO:0007275 multicellular organism development 53 53/113 SFN/ACTB/ANXA1/ANXA2/ANXA3/SERPINC1/APOA1/APOE/ARG1/B2M/CLU/CFL1/C1QC/C3/CDSN/SPRR1B/DMBT1/DSG1/DSG4/FLG2/HSP90AB1/HRG/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/HRNR/ICAM1/FN1/GSN/PKP1/DSP/LTF/CD74/LDHA/PFN1/S100A8/TGM3/F2/SERPINB12/SPRR2G/SPRR3/SLC34A2 +Bred GO:0007389 pattern specification process 0 0/113 +Bred GO:0007585 respiratory gaseous exchange 2 2/113 SFTPA1/SFTPC +Bred GO:0007586 digestion 2 2/113 APOA1/SERPINA3 +Bred GO:0008340 determination of adult lifespan 0 0/113 +Bred GO:0009561 megagametogenesis 0 0/113 +Bred GO:0009791 post-embryonic development 0 0/113 +Bred GO:0009845 seed germination 0 0/113 +Bred GO:0010022 meristem determinacy 0 0/113 +Bred GO:0010073 meristem maintenance 0 0/113 +Bred GO:0010162 seed dormancy process 0 0/113 +Bred GO:0010232 vascular transport 0 0/113 +Bred GO:0016203 muscle attachment 0 0/113 +Bred GO:0019827 stem cell population maintenance 0 0/113 +Bred GO:0022004 midbrain-hindbrain boundary maturation during brain development 0 0/113 +Bred GO:0022005 midbrain-hindbrain boundary maturation during neural plate development 0 0/113 +Bred GO:0022404 molting cycle process 2 2/113 DSG4/TGM3 +Bred GO:0030431 sleep 0 0/113 +Bred GO:0030588 pseudocleavage 0 0/113 +Bred GO:0031424 keratinization 11 11/113 SFN/CDSN/SPRR1B/DSG1/DSG4/HRNR/PKP1/DSP/TGM3/SPRR2G/SPRR3 +Bred GO:0032898 neurotrophin production 0 0/113 +Bred GO:0032922 circadian regulation of gene expression 0 0/113 +Bred GO:0032941 secretion by tissue 0 0/113 +Bred GO:0033555 multicellular organismal response to stress 1 1/113 APOE +Bred GO:0034381 plasma lipoprotein particle clearance 4 4/113 ANXA2/APOA1/APOE/NPC2 +Bred GO:0035073 pupariation 0 0/113 +Bred GO:0035074 pupation 0 0/113 +Bred GO:0035264 multicellular organism growth 0 0/113 +Bred GO:0035265 organ growth 0 0/113 +Bred GO:0035314 scab formation 0 0/113 +Bred GO:0035889 otolith tethering 0 0/113 +Bred GO:0036363 transforming growth factor beta activation 1 1/113 HSP90AB1 +Bred GO:0042303 molting cycle 2 2/113 DSG4/TGM3 +Bred GO:0043480 pigment accumulation in tissues 0 0/113 +Bred GO:0044266 multicellular organismal macromolecule catabolic process 0 0/113 +Bred GO:0044274 multicellular organismal biosynthetic process 0 0/113 +Bred GO:0044706 multi-multicellular organism process 3 3/113 ARG1/DSG1/AMBP +Bred GO:0045494 photoreceptor cell maintenance 0 0/113 +Bred GO:0048647 polyphenic determination 0 0/113 +Bred GO:0048771 tissue remodeling 3 3/113 ANXA1/ARG1/HRG +Bred GO:0048871 multicellular organismal homeostasis 18 18/113 SFN/ACTB/B2M/CST4/FLG2/HRNR/JCHAIN/SERPINA3/LTF/LCN1/LYZ/PIGR/PIP/PRR4/TF/ALB/AZGP1/ZG16B +Bred GO:0050817 coagulation 12 12/113 YWHAZ/ACTB/A2M/ANXA2/ANXA5/SERPINC1/APOE/HBB/HRG/SERPINA1/SERPING1/F2 +Bred GO:0050879 multicellular organismal movement 0 0/113 +Bred GO:0051239 regulation of multicellular organismal process 41 41/113 SFN/ORM1/ANXA1/ANXA2/ANXA3/ANXA5/SERPINC1/APOA1/APOE/ARG1/B2M/CLU/CFL1/C1QC/C3/CDSN/GAPDH/HSP90AB1/HRG/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/FN1/DSP/LTF/CD74/SERPING1/PFN1/F2 +Bred GO:0051240 positive regulation of multicellular organismal process 16 16/113 ORM1/ANXA1/ANXA2/ANXA3/APOE/B2M/CLU/C3/GAPDH/HRG/ICAM1/FN1/LTF/CD74/PFN1/F2 +Bred GO:0051241 negative regulation of multicellular organismal process 31 31/113 ORM1/ANXA1/ANXA2/ANXA5/APOA1/APOE/ARG1/B2M/C1QC/CDSN/HSP90AB1/HRG/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/FN1/LTF/CD74/SERPING1/F2 +Bred GO:0055046 microgametogenesis 0 0/113 +Bred GO:0055127 vibrational conductance of sound to the inner ear 0 0/113 +Bred GO:0060384 innervation 0 0/113 +Bred GO:0071684 organism emergence from protective structure 0 0/113 +Bred GO:0071827 plasma lipoprotein particle organization 3 3/113 APOA1/APOE/ALB +Bred GO:0090130 tissue migration 5 5/113 ANXA3/APOA1/APOE/HRG/PFN1 +Bred GO:0090664 response to high population density 0 0/113 +Bred GO:0097167 circadian regulation of translation 0 0/113 +Bred GO:0097207 bud dormancy process 0 0/113 +Bred GO:0097242 amyloid-beta clearance 3 3/113 APOE/CLU/C3 +Bred GO:1990110 callus formation 0 0/113 +Bred GO:0009653 anatomical structure morphogenesis 18 18/113 ANXA1/ANXA2/ANXA3/APOA1/APOE/ARG1/CLU/CFL1/C3/CDSN/HRG/ICAM1/FN1/DSP/LTF/PFN1/TGM3/F2 +Bred GO:0007568 aging 4 4/113 ARG1/ICAM1/GSN/SERPING1 +Bred GO:0007571 age-dependent general metabolic decline 0 0/113 +Bred GO:0009838 abscission 0 0/113 +Bred GO:0009847 spore germination 0 0/113 +Bred GO:0010014 meristem initiation 0 0/113 +Bred GO:0048646 anatomical structure formation involved in morphogenesis 7 7/113 ANXA2/ANXA3/CFL1/C3/HRG/FN1/PFN1 +Bred GO:0021700 developmental maturation 1 1/113 LTF +Bred GO:0022611 dormancy process 0 0/113 +Bred GO:0031128 developmental induction 0 0/113 +Bred GO:0097737 acquisition of mycelium reproductive competence 0 0/113 +Bred GO:0043696 dedifferentiation 0 0/113 +Bred GO:0043934 sporulation 0 0/113 +Bred GO:0044111 development involved in symbiotic interaction 1 1/113 ANXA2 +Bred GO:0048532 anatomical structure arrangement 0 0/113 +Bred GO:0048856 anatomical structure development 54 54/113 SFN/ACTB/ANXA1/ANXA2/ANXA3/SERPINC1/APOA1/APOE/ARG1/B2M/CLU/CFL1/C1QC/C3/CDSN/SPRR1B/DMBT1/DSG1/DSG4/FABP5/FLG2/HSP90AB1/HRG/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/HRNR/ICAM1/FN1/GSN/PKP1/DSP/LTF/CD74/LDHA/PFN1/S100A8/TGM3/F2/SERPINB12/SPRR2G/SPRR3/SLC34A2 +Bred GO:0050793 regulation of developmental process 33 33/113 SFN/ANXA1/ANXA2/ANXA3/APOA1/APOE/B2M/CFL1/C1QC/C3/CDSN/HSP90AB1/HRG/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/FN1/LTF/CD74/PFN1/F2 +Bred GO:0051093 negative regulation of developmental process 24 24/113 ANXA1/ANXA2/APOE/B2M/C1QC/CDSN/HRG/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/LTF/CD74/F2 +Bred GO:0051094 positive regulation of developmental process 10 10/113 SFN/ANXA1/ANXA3/APOA1/APOE/C3/HSP90AB1/FN1/LTF/CD74 +Bred GO:0060033 anatomical structure regression 0 0/113 +Bred GO:0090644 age-related resistance 0 0/113 +Bred GO:0098727 maintenance of cell number 0 0/113 +Bred GO:0031987 locomotion involved in locomotory behavior 0 0/113 +Bred GO:0033058 directional locomotion 0 0/113 +Bred GO:0036268 swimming 0 0/113 +Bred GO:0040012 regulation of locomotion 8 8/113 ANXA1/ANXA3/APOE/HRG/ICAM1/FN1/CD74/PFN1 +Bred GO:0040013 negative regulation of locomotion 2 2/113 APOE/HRG +Bred GO:0040017 positive regulation of locomotion 5 5/113 ANXA3/ICAM1/FN1/CD74/PFN1 +Bred GO:0042330 taxis 7 7/113 ANXA1/APOA1/HRG/CD74/DEFA1/DEFA1B/S100A8 +Bred GO:0048870 cell motility 16 16/113 ANXA1/ANXA3/APOA1/APOE/CFL1/HRG/ICAM1/IGLL1/JCHAIN/FN1/CD74/DEFA1/DEFA1B/PFN1/S100A8/F2 +Bred GO:0051821 dissemination or transmission of organism from other organism involved in symbiotic interaction 0 0/113 +Bred GO:0052192 movement in environment of other organism involved in symbiotic interaction 0 0/113 +Bred GO:0060361 flight 0 0/113 +Bred GO:0071965 multicellular organismal locomotion 0 0/113 +Bred GO:0033060 ocellus pigmentation 0 0/113 +Bred GO:0043474 pigment metabolic process involved in pigmentation 0 0/113 +Bred GO:0043476 pigment accumulation 0 0/113 +Bred GO:0048066 developmental pigmentation 0 0/113 +Bred GO:0022403 cell cycle phase 0 0/113 +Bred GO:0022601 menstrual cycle phase 0 0/113 +Bred GO:0044851 hair cycle phase 0 0/113 +Bred GO:0060206 estrous cycle phase 0 0/113 +Bred GO:0072690 single-celled organism vegetative growth phase 0 0/113 +Bred GO:0007623 circadian rhythm 0 0/113 +Bred GO:0007624 ultradian rhythm 0 0/113 +Bred GO:0042698 ovulation cycle 2 2/113 ANXA1/ICAM1 +Bred GO:0032846 positive regulation of homeostatic process 2 2/113 ANXA1/F2 +Bred GO:0042753 positive regulation of circadian rhythm 0 0/113 +Bred GO:0043902 positive regulation of multi-organism process 6 6/113 APOE/ARG1/CFL1/GAPDH/CD74/PFN1 +Bred GO:0044089 positive regulation of cellular component biogenesis 7 7/113 APOA1/CLU/HRG/ICAM1/JCHAIN/GSN/PFN1 +Bred GO:0045760 positive regulation of action potential 0 0/113 +Bred GO:0045785 positive regulation of cell adhesion 6 6/113 ANXA1/APOA1/HRG/ICAM1/FN1/CD74 +Bred GO:0048087 positive regulation of developmental pigmentation 0 0/113 +Bred GO:0048584 positive regulation of response to stimulus 30 30/113 SFN/YWHAZ/ACTB/A2M/ANXA1/APOA1/ARG1/B2M/CLU/C1QC/C2/C3/C4A/C4B/C4B/DMBT1/HSP90AA1/HSP90AB1/HPX/HRG/ICAM1/IGLL1/GSN/LTF/CD74/SERPING1/S100A8/F2/SFTPA1/TXN +Bred GO:0051050 positive regulation of transport 18 18/113 SFN/YWHAZ/ORM1/ANXA1/ANXA2/APOE/B2M/C2/C3/C4A/C4B/C4B/GAPDH/HSP90AB1/PCNT/S100A8/F2/TF +Bred GO:0051091 positive regulation of DNA binding transcription factor activity 5 5/113 ANXA3/CLU/ICAM1/LTF/S100A8 +Bred GO:0051919 positive regulation of fibrinolysis 0 0/113 +Bred GO:0060301 positive regulation of cytokine activity 0 0/113 +Bred GO:1900048 positive regulation of hemostasis 2 2/113 HRG/F2 +Bred GO:1900097 positive regulation of dosage compensation by inactivation of X chromosome 0 0/113 +Bred GO:1900454 positive regulation of long term synaptic depression 0 0/113 +Bred GO:1902474 positive regulation of protein localization to synapse 0 0/113 +Bred GO:1902632 positive regulation of membrane hyperpolarization 0 0/113 +Bred GO:1902685 positive regulation of receptor localization to synapse 0 0/113 +Bred GO:1903549 positive regulation of growth hormone activity 0 0/113 +Bred GO:1903666 positive regulation of asexual reproduction 0 0/113 +Bred GO:1903829 positive regulation of cellular protein localization 5 5/113 SFN/YWHAZ/HSP90AB1/PCNT/F2 +Bred GO:1904181 positive regulation of membrane depolarization 0 0/113 +Bred GO:1904582 positive regulation of intracellular mRNA localization 0 0/113 +Bred GO:1904704 positive regulation of protein localization to cell-cell adherens junction 0 0/113 +Bred GO:1904874 positive regulation of telomerase RNA localization to Cajal body 0 0/113 +Bred GO:1904912 positive regulation of establishment of RNA localization to telomere 0 0/113 +Bred GO:1904915 positive regulation of establishment of macromolecular complex localization to telomere 0 0/113 +Bred GO:1904951 positive regulation of establishment of protein localization 7 7/113 SFN/YWHAZ/ORM1/GAPDH/HSP90AB1/PCNT/F2 +Bred GO:1905099 positive regulation of guanyl-nucleotide exchange factor activity 0 0/113 +Bred GO:1905339 positive regulation of cohesin unloading 0 0/113 +Bred GO:1905514 positive regulation of short-term synaptic potentiation 0 0/113 +Bred GO:1905605 positive regulation of maintenance of permeability of blood-brain barrier 0 0/113 +Bred GO:1905954 positive regulation of lipid localization 3 3/113 ANXA2/APOE/C3 +Bred GO:2000199 positive regulation of ribonucleoprotein complex localization 0 0/113 +Bred GO:2000327 positive regulation of ligand-dependent nuclear receptor transcription coactivator activity 0 0/113 +Bred GO:0008588 release of cytoplasmic sequestered NF-kappaB 0 0/113 +Bred GO:0034260 negative regulation of GTPase activity 0 0/113 +Bred GO:0032845 negative regulation of homeostatic process 2 2/113 CD74/F2 +Bred GO:0042754 negative regulation of circadian rhythm 0 0/113 +Bred GO:0043433 negative regulation of DNA binding transcription factor activity 0 0/113 +Bred GO:0043901 negative regulation of multi-organism process 3 3/113 ANXA2/GSN/LTF +Bred GO:0045759 negative regulation of action potential 0 0/113 +Bred GO:0048086 negative regulation of developmental pigmentation 0 0/113 +Bred GO:0048585 negative regulation of response to stimulus 15 15/113 A2M/ANXA1/ANXA2/APOA1/APOE/ARG1/CLU/HRG/ICAM1/LTF/CD74/SERPING1/AMBP/F2/TXN +Bred GO:0051051 negative regulation of transport 6 6/113 ANXA1/APOA1/ICAM1/FN1/CD74/TXN +Bred GO:0051918 negative regulation of fibrinolysis 2 2/113 HRG/F2 +Bred GO:0060302 negative regulation of cytokine activity 0 0/113 +Bred GO:1900047 negative regulation of hemostasis 5 5/113 ANXA2/APOE/HRG/SERPING1/F2 +Bred GO:1900096 negative regulation of dosage compensation by inactivation of X chromosome 0 0/113 +Bred GO:1900272 negative regulation of long-term synaptic potentiation 1 1/113 APOE +Bred GO:1900453 negative regulation of long term synaptic depression 0 0/113 +Bred GO:1902631 negative regulation of membrane hyperpolarization 0 0/113 +Bred GO:1902684 negative regulation of receptor localization to synapse 0 0/113 +Bred GO:1902886 negative regulation of proteasome-activating ATPase activity 0 0/113 +Bred GO:1903548 negative regulation of growth hormone activity 0 0/113 +Bred GO:1903665 negative regulation of asexual reproduction 0 0/113 +Bred GO:1903828 negative regulation of cellular protein localization 1 1/113 TXN +Bred GO:1904180 negative regulation of membrane depolarization 0 0/113 +Bred GO:1904537 negative regulation of mitotic telomere tethering at nuclear periphery 0 0/113 +Bred GO:1904581 negative regulation of intracellular mRNA localization 0 0/113 +Bred GO:1904703 negative regulation of protein localization to cell-cell adherens junction 0 0/113 +Bred GO:1904873 negative regulation of telomerase RNA localization to Cajal body 0 0/113 +Bred GO:1904911 negative regulation of establishment of RNA localization to telomere 0 0/113 +Bred GO:1904914 negative regulation of establishment of macromolecular complex localization to telomere 0 0/113 +Bred GO:1904950 negative regulation of establishment of protein localization 4 4/113 ANXA1/APOA1/FN1/TXN +Bred GO:1905098 negative regulation of guanyl-nucleotide exchange factor activity 0 0/113 +Bred GO:1905338 negative regulation of cohesin unloading 0 0/113 +Bred GO:1905385 negative regulation of protein localization to presynapse 0 0/113 +Bred GO:1905513 negative regulation of short-term synaptic potentiation 0 0/113 +Bred GO:1905604 negative regulation of maintenance of permeability of blood-brain barrier 0 0/113 +Bred GO:1905869 negative regulation of 3'-UTR-mediated mRNA stabilization 0 0/113 +Bred GO:1905953 negative regulation of lipid localization 0 0/113 +Bred GO:2000198 negative regulation of ribonucleoprotein complex localization 0 0/113 +Bred GO:2000326 negative regulation of ligand-dependent nuclear receptor transcription coactivator activity 0 0/113 +Bred GO:0030155 regulation of cell adhesion 9 9/113 ANXA1/APOA1/ARG1/CDSN/HRG/ICAM1/FN1/GSN/CD74 +Bred GO:0032844 regulation of homeostatic process 4 4/113 ANXA1/B2M/CD74/F2 +Bred GO:0032879 regulation of localization 29 29/113 SFN/YWHAZ/ORM1/ANXA1/ANXA2/ANXA3/APOA1/APOE/ARG1/B2M/C2/C3/C4A/C4B/C4B/GAPDH/HSP90AB1/HRG/ICAM1/FN1/GSN/DSP/CD74/PCNT/PFN1/S100A8/F2/TF/TXN +Bred GO:0042752 regulation of circadian rhythm 0 0/113 +Bred GO:0043900 regulation of multi-organism process 9 9/113 ANXA2/APOE/ARG1/CFL1/GAPDH/GSN/LTF/CD74/PFN1 +Bred GO:0044087 regulation of cellular component biogenesis 9 9/113 APOA1/APOE/CLU/HSP90AA1/HRG/ICAM1/JCHAIN/GSN/PFN1 +Bred GO:0048070 regulation of developmental pigmentation 0 0/113 +Bred GO:0048518 positive regulation of biological process 61 61/113 SFN/YWHAZ/ACTB/ORM1/A2M/ANXA1/ANXA2/ANXA3/APOA1/APOE/ARG1/B2M/CLU/CFL1/C1QC/C2/C3/C4A/C4B/C4B/DMBT1/GAPDH/HP/HSP90AA1/HSP90AB1/HBB/HPX/HRG/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/IGLL1/JCHAIN/FN1/GSN/PKP1/LTF/CD74/LDHA/LCN2/PCNT/SERPING1/PFN1/PIP/S100A8/F2/SFTPA1/TF/TXN +Bred GO:0048519 negative regulation of biological process 59 59/113 SFN/YWHAZ/ORM1/A2M/ANXA1/ANXA2/ANXA5/SERPINC1/APOA1/APOE/ARG1/B2M/CLU/CFL1/C1QC/C3/C4A/C4B/C4B/CDSN/CST4/GAPDH/HP/HSP90AB1/HRG/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/ITIH1/SERPINA3/SERPINA1/FN1/GSN/ITIH4/PKP1/LTF/CD74/LCN1/SERPING1/PFN1/PIP/AMBP/F2/SERPINB12/ALB/TXN/AZGP1 +Bred GO:0048583 regulation of response to stimulus 37 37/113 SFN/YWHAZ/ACTB/A2M/ANXA1/ANXA2/SERPINC1/APOA1/APOE/ARG1/B2M/CLU/C1QC/C2/C3/C4A/C4B/C4B/DMBT1/HSP90AA1/HSP90AB1/HPX/HRG/ICAM1/IGLL1/FN1/GSN/LTF/CD74/SERPING1/PIGR/AMBP/S100A8/F2/SFTPA1/TXN/TTR +Bred GO:0071898 regulation of estrogen receptor binding 0 0/113 +Bred GO:0097006 regulation of plasma lipoprotein particle levels 5 5/113 ANXA2/APOA1/APOE/NPC2/ALB +Bred GO:0098900 regulation of action potential 1 1/113 DSP +Bred GO:1900046 regulation of hemostasis 6 6/113 ANXA2/SERPINC1/APOE/HRG/SERPING1/F2 +Bred GO:1902630 regulation of membrane hyperpolarization 0 0/113 +Bred GO:1903664 regulation of asexual reproduction 0 0/113 +Bred GO:1905097 regulation of guanyl-nucleotide exchange factor activity 0 0/113 +Bred GO:1905603 regulation of maintenance of permeability of blood-brain barrier 0 0/113 +Bred GO:0006950 response to stress 74 74/113 SFN/YWHAZ/ACTB/ORM1/A2M/ANXA1/ANXA2/ANXA3/ANXA5/SERPINC1/APOA1/APOE/ARG1/B2M/CLU/C1QC/C2/C3/C4A/C4B/C4B/DMBT1/LGALS3BP/GAPDH/HP/HSP90AA1/HSP90AB1/HBB/HPX/HRG/HIST1H2BF/HIST1H2BG/HIST1H2BC/HIST1H2BI/HIST1H2BE/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/IGLL1/JCHAIN/SERPINA3/SERPINA1/FN1/GSN/ITIH4/DSP/LTF/CD74/LDHA/LYZ/MRC1/DEFA1/DEFA1B/LCN2/SERPING1/AMBP/S100A8/F2/SFTPA1/ALB/SPRR3/TXN +Bred GO:0009605 response to external stimulus 43 43/113 A2M/ANXA1/ANXA2/ANXA3/SERPINC1/APOA1/APOE/ARG1/B2M/CLU/CFL1/C1QC/C2/C3/C4A/C4B/C4B/DMBT1/NPC2/GAPDH/HP/HRG/HIST1H2BF/HIST1H2BG/HIST1H2BC/HIST1H2BI/HIST1H2BE/ICAM1/IGLL1/JCHAIN/GSN/LTF/CD74/LDHA/LYZ/MRC1/DEFA1/DEFA1B/LCN2/SERPING1/S100A8/F2/ALB +Bred GO:0009607 response to biotic stimulus 28 28/113 ANXA3/ARG1/B2M/CLU/CFL1/C4B/C4B/DMBT1/NPC2/GAPDH/HP/HRG/HIST1H2BF/HIST1H2BG/HIST1H2BC/HIST1H2BI/HIST1H2BE/ICAM1/IGLL1/JCHAIN/LTF/LYZ/MRC1/DEFA1/DEFA1B/LCN2/S100A8/F2 +Bred GO:0009628 response to abiotic stimulus 6 6/113 ANXA1/HSP90AA1/HSP90AB1/ICAM1/LDHA/TXN +Bred GO:0009719 response to endogenous stimulus 11 11/113 ANXA1/ANXA2/ANXA3/APOE/ARG1/DSG1/DSG4/HSP90AB1/ICAM1/DEFA1/DEFA1B +Bred GO:0014823 response to activity 0 0/113 +Bred GO:0014854 response to inactivity 0 0/113 +Bred GO:0014874 response to stimulus involved in regulation of muscle adaptation 0 0/113 +Bred GO:0042221 response to chemical 43 43/113 ANXA1/ANXA2/ANXA3/ANXA5/SERPINC1/APOA1/APOE/ARG1/B2M/BLMH/CLU/CFL1/C2/C4B/C4B/CST4/DSG1/DSG4/GAPDH/HP/HSP90AA1/HSP90AB1/HBB/HPX/HRG/ICAM1/GSN/ITIH4/LTF/CD74/LDHA/MRC1/DEFA1/DEFA1B/LCN2/PIGR/PFN1/PIP/S100A8/TF/ALB/TXN/AZGP1 +Bred GO:0043500 muscle adaptation 1 1/113 GSN +Bred GO:0043627 response to estrogen 3 3/113 APOA1/LDHA/SLC34A2 +Bred GO:0051606 detection of stimulus 6 6/113 C4B/C4B/CST4/PIGR/PIP/AZGP1 +Bred GO:0051775 response to redox state 0 0/113 +Bred GO:0072376 protein activation cascade 12 12/113 A2M/SERPINC1/CLU/C1QC/C2/C3/C4A/C4B/C4B/IGLL1/SERPING1/F2 +Bred GO:0032187 actomyosin contractile ring localization 0 0/113 +Bred GO:0033036 macromolecule localization 27 27/113 SFN/YWHAZ/ORM1/ANXA1/ANXA2/APOA1/APOE/CLU/C3/DMBT1/NPC2/GAPDH/HSP90AA1/HSP90AB1/FN1/GSN/DSP/CD74/LCN1/PCNT/PIGR/F2/SFTPA1/TF/ALB/TXN/AZGP1 +Bred GO:0035732 nitric oxide storage 0 0/113 +Bred GO:0051234 establishment of localization 72 72/113 SFN/YWHAZ/ACTB/AFM/ORM1/A1BG/A2M/ANXA1/ANXA2/ANXA3/ANXA5/SERPINC1/APOA1/APOE/ARG1/B2M/CTSD/CP/CLU/C2/C3/C4A/C4B/C4B/DMBT1/DSG1/NPC2/FABP5/FLG2/LGALS3BP/GAPDH/HP/HSP90AA1/HSP90AB1/HBB/HPX/HRG/HRNR/ICAM1/IGLL1/JCHAIN/SERPINA3/SERPINA1/FN1/GSN/GC/ITIH4/PKP1/DSP/LTF/CD74/LCN1/LYZ/MRC1/DEFA1/DEFA1B/LCN2/PCNT/SERPING1/PIGR/PIP/AMBP/S100A8/F2/SFTPA1/TF/SERPINB12/ALB/SLC34A2/TXN/TTR/AZGP1 +Bred GO:0051235 maintenance of location 7 7/113 APOA1/APOE/C3/GSN/S100A8/F2/ALB +Bred GO:0051641 cellular localization 16 16/113 SFN/YWHAZ/ANXA2/APOE/CLU/NPC2/HSP90AA1/HSP90AB1/SERPINA1/GSN/CD74/PCNT/PIGR/F2/ALB/TXN +Bred GO:0051674 localization of cell 16 16/113 ANXA1/ANXA3/APOA1/APOE/CFL1/HRG/ICAM1/IGLL1/JCHAIN/FN1/CD74/DEFA1/DEFA1B/PFN1/S100A8/F2 +Bred GO:0061842 microtubule organizing center localization 0 0/113 +Bred GO:1902579 multi-organism localization 0 0/113 +Bred GO:0051707 response to other organism 28 28/113 ANXA3/ARG1/B2M/CLU/CFL1/C4B/C4B/DMBT1/NPC2/GAPDH/HP/HRG/HIST1H2BF/HIST1H2BG/HIST1H2BC/HIST1H2BI/HIST1H2BE/ICAM1/IGLL1/JCHAIN/LTF/LYZ/MRC1/DEFA1/DEFA1B/LCN2/S100A8/F2 +Bred GO:0044366 feeding on or from other organism 0 0/113 +Bred GO:0044419 interspecies interaction between organisms 23 23/113 ANXA2/APOE/ARG1/B2M/CFL1/DMBT1/GAPDH/HSP90AB1/HPX/HRG/ICAM1/FN1/GSN/LTF/CD74/LYZ/MRC1/DEFA1/DEFA1B/PFN1/AMBP/F2/ALB +Bred GO:0051703 intraspecies interaction between organisms 0 0/113 +Bred GO:0051816 acquisition of nutrients from other organism during symbiotic interaction 0 0/113 +Bred GO:0098630 aggregation of unicellular organisms 0 0/113 +Bred GO:0098740 multi organism cell adhesion 0 0/113 +Bred GO:0050789 regulation of biological process 83 83/113 SFN/YWHAZ/ACTB/ORM1/A2M/ANXA1/ANXA2/ANXA3/ANXA5/SERPINC1/APOA1/APOE/ARG1/B2M/CLU/CFL1/C1QC/C2/C3/C4A/C4B/C4B/CDSN/CST4/DMBT1/DSG4/NPC2/LGALS3BP/GAPDH/HP/HSP90AA1/HSP90AB1/HBB/HPX/HRG/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/IGLL1/JCHAIN/ITIH1/SERPINA3/SERPINA1/FN1/GSN/ITIH4/PKP1/DSP/LTF/CD74/LCN1/LDHA/MRC1/DEFA1/DEFA1B/LCN2/PCNT/SERPING1/PIGR/PFN1/PIP/AMBP/S100A8/F2/SFTPA1/TF/SERPINB12/ALB/TXN/TTR/AZGP1 +Bred GO:0065008 regulation of biological quality 66 66/113 SFN/YWHAZ/ACTB/A2M/ANXA1/ANXA2/ANXA5/SERPINC1/APOA1/APOE/B2M/CP/CLU/CFL1/C3/CST4/DSG1/NPC2/FLG2/GAPDH/HSP90AA1/HSP90AB1/HBB/HPX/HRG/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/HRNR/ICAM1/JCHAIN/SERPINA3/SERPINA1/FN1/GSN/DSP/LTF/CD74/LCN1/LYZ/LCN2/SERPING1/PIGR/PFN1/PIP/PRR4/S100A8/F2/TF/ALB/SLC34A2/TXN/TTR/AZGP1/ZG16B +Bred GO:0065009 regulation of molecular function 39 39/113 SFN/A2M/ANXA1/ANXA2/ANXA3/ANXA5/SERPINC1/APOA1/APOE/B2M/CLU/C3/C4A/C4B/C4B/CST4/GAPDH/HP/HSP90AA1/HSP90AB1/HRG/ICAM1/ITIH1/SERPINA3/SERPINA1/FN1/GSN/ITIH4/LTF/CD74/LCN1/SERPING1/PFN1/AMBP/S100A8/F2/SERPINB12/TXN/TTR +Bred GO:1902727 negative regulation of growth factor dependent skeletal muscle satellite cell proliferation 0 0/113 +Bred GO:1902728 positive regulation of growth factor dependent skeletal muscle satellite cell proliferation 0 0/113 +Bred GO:0044085 cellular component biogenesis 43 43/113 YWHAZ/ACTB/ANXA2/APOA1/APOE/ARG1/CLU/DSG1/HSP90AA1/HSP90AB1/HBB/HRG/HIST1H2BD/HIST1H2BF/HIST1H2BG/HIST1H2BC/HIST1H2BI/HIST1H2BE/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/ICAM1/JCHAIN/SERPINA1/FN1/GSN/PKP1/CD74/LCN2/PCNT/PFN1/TGM3 +Bred GO:0001502 cartilage condensation 0 0/113 +Bred GO:0009407 toxin catabolic process 0 0/113 +Bred GO:0010127 mycothiol-dependent detoxification 0 0/113 +Bred GO:0010312 detoxification of zinc ion 0 0/113 +Bred GO:0051410 detoxification of nitrogen compound 0 0/113 +Bred GO:0061687 detoxification of inorganic compound 0 0/113 +Bred GO:0071722 detoxification of arsenic-containing substance 0 0/113 +Bred GO:1990748 cellular detoxification 5 5/113 APOE/HP/HBB/ALB/TXN +Bred GO:0016080 synaptic vesicle targeting 0 0/113 +Bred GO:0007269 neurotransmitter secretion 0 0/113 +Bred GO:0016079 synaptic vesicle exocytosis 0 0/113 +Bred GO:0016081 synaptic vesicle docking 0 0/113 +Bred GO:0016082 synaptic vesicle priming 0 0/113 +Bred GO:0031629 synaptic vesicle fusion to presynaptic active zone membrane 0 0/113 +Bred GO:0051583 dopamine uptake involved in synaptic transmission 0 0/113 +Bred GO:0099069 synaptic vesicle tethering involved in synaptic vesicle exocytosis 0 0/113 +Bred GO:0099502 calcium-dependent activation of synaptic vesicle fusion 0 0/113 +Bred GO:0099703 induction of synaptic vesicle exocytosis by positive regulation of presynaptic cytosolic calcium ion concentration 0 0/113 +Muc GO:0019953 sexual reproduction 4 4/181 KRT9/HSPA2/ALDOA/CCT8 +Muc GO:0019954 asexual reproduction 0 0/181 +Muc GO:0022414 reproductive process 8 8/181 KRT9/SERPINB5/DSG1/HSPA2/ANXA1/ALDOA/CCT8/ARG1 +Muc GO:0032504 multicellular organism reproduction 5 5/181 KRT9/DSG1/HSPA2/ANXA1/ARG1 +Muc GO:0032505 reproduction of a single-celled organism 0 0/181 +Muc GO:0061887 reproduction of symbiont in host 0 0/181 +Muc GO:0055114 oxidation-reduction process 19 19/181 PRDX1/TPI1/TXN/GAPDH/UBC/ENO1/LDHA/PRDX6/PKM/CAT/PGK1/PRDX2/PHGDH/ALDOA/ALDH2/APOD/MDH1/MDH2/ALDH9A1 +Muc GO:0006807 nitrogen compound metabolic process 133 133/181 KRT2/KRT17/CSTA/KRT10/FABP5/SPRR2E/HSPB1/HIST1H2AH/PRDX1/ACTB/S100A11/S100A9/JUP/PKP1/TPI1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/TXN/DSP/ALB/GAPDH/LGALS3/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/MIF/SERPINB5/EEF1A1/HIST1H2BK/LDHA/ANXA2/RPSA/GSTP1/SERPINB12/PRDX6/NME2/SERPINB3/TGM3/PKM/LCN1/FGG/HSPA2/SPRR1A/FGB/RAB7A/PSMB6/PSMB4/S100A8/FGA/C1orf68/CAT/PGK1/RPS15A/SLPI/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/HBB/KLK5/HSPA5/LYZ/AZGP1/TGM1/RPL12/ATP5B/PHGDH/TALDO1/ANXA1/ALDOA/CCT8/ACTN4/GM2A/GGCT/TRIM29/EIF4A1/IVL/SERPINB2/PSMB5/DDX3Y/PSMA2/RNH1/CASP14/LOR/APOD/GSN/KLK7/RPS2/ARG1/MDH1/MDH2/AGA/SERPINB13/YOD1/HSP90AA1/LTF/NEU2/AHCY/CTSD/SERPINA12/ALDH9A1/A2M/EEF1G/HNRNPK/HSPD1/TKT/PCBP1/CRABP2/IDE/LY6D +Muc GO:0009056 catabolic process 47 47/181 FABP5/HSPB1/PRDX1/S100A9/PKP1/TPI1/GAPDH/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/EEF1A1/LDHA/ANXA2/RPSA/SERPINB12/PRDX6/PKM/RAB7A/PSMB6/PSMB4/S100A8/CAT/PGK1/RPS15A/PRDX2/HBB/HSPA5/LYZ/RPL12/ALDOA/GM2A/EIF4A1/HP/PSMB5/PSMA2/RNH1/ALDH2/RPS2/ARG1/YOD1/HSP90AA1/NEU2/AHCY/CTSD/IDE +Muc GO:0009058 biosynthetic process 84 84/181 KRT17/FABP5/HSPB1/HIST1H2AH/S100A11/S100A9/JUP/TPI1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/TXN/GAPDH/DYNLL1/UBC/HSPA8/ENO1/MIF/EEF1A1/RPSA/GSTP1/NME2/PKM/PSMB6/PSMB4/S100A8/CAT/PGK1/RPS15A/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/HBB/HSPA5/RPL12/ATP5B/PHGDH/TALDO1/ANXA1/ALDOA/CCT8/ACTN4/GGCT/TRIM29/EIF4A1/PSMB5/DDX3Y/PSMA2/RPS2/ARG1/MDH1/MDH2/HSP90AA1/LTF/AHCY/SERPINA12/ALDH9A1/EEF1G/HNRNPK/HSPD1/TKT/PCBP1/CRABP2/LY6D +Muc GO:0009892 negative regulation of metabolic process 66 66/181 CSTA/HSPB1/HIST1H2AH/S100A11/PKP1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/TXN/GAPDH/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/MIF/SERPINB5/ANXA2/RPSA/GSTP1/SERPINB12/SERPINB3/LCN1/PSMB6/PSMB4/RPS15A/SLPI/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/RPL12/TRIM29/EIF4A1/HP/SERPINB2/PSMB5/PSMA2/RNH1/APOD/RPS2/SERPINB13/YOD1/LTF/SERPINA12/A2M/HNRNPK/IDE +Muc GO:0009893 positive regulation of metabolic process 64 64/181 KRT17/HSPB1/ACTB/S100A9/PKP1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/TXN/UBC/HSPA8/ENO1/MIF/ANXA2/GSTP1/PRDX6/NME2/SERPINB3/FGG/HSPA2/LCN2/FGB/RAB7A/PSMB6/PSMB4/S100A8/FGA/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/HBB/HSPA5/ANXA1/LMNA/CCT8/PSMB5/PSMA2/GSN/HSP90AA1/LTF/HNRNPK/HSPD1/PCBP1/IDE +Muc GO:0018933 nicotine metabolic process 0 0/181 +Muc GO:0019222 regulation of metabolic process 96 96/181 KRT17/CSTA/HSPB1/HIST1H2AH/PRDX1/ACTB/S100A11/S100A9/JUP/PKP1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/TXN/GAPDH/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/MIF/SERPINB5/EEF1A1/ANXA2/RPSA/GSTP1/SERPINB12/PRDX6/NME2/SERPINB3/LCN1/FGG/HSPA2/LCN2/FGB/RAB7A/PSMB6/PSMB4/S100A8/FGA/CAT/RPS15A/SLPI/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/HBB/HSPA5/RPL12/ANXA1/LMNA/CCT8/ACTN4/TRIM29/EIF4A1/HP/SERPINB2/PSMB5/DDX3Y/PSMA2/RNH1/APOD/GSN/RPS2/SERPINB13/YOD1/HSP90AA1/LTF/SERPINA12/A2M/HNRNPK/HSPD1/PCBP1/CRABP2/IDE +Muc GO:0019694 alkanesulfonate metabolic process 0 0/181 +Muc GO:0019748 secondary metabolic process 0 0/181 +Muc GO:0032259 methylation 5 5/181 HSPA8/EEF1A1/EEF2/RPS2/AHCY +Muc GO:0042440 pigment metabolic process 0 0/181 +Muc GO:0042445 hormone metabolic process 3 3/181 ALDH9A1/CRABP2/IDE +Muc GO:0044033 multi-organism metabolic process 1 1/181 ANXA2 +Muc GO:0044236 multicellular organism metabolic process 2 2/181 ARG1/CTSD +Muc GO:0044237 cellular metabolic process 133 133/181 KRT2/KRT17/CSTA/KRT10/FABP5/SPRR2E/HSPB1/HIST1H2AH/PRDX1/ACTB/S100A11/S100A9/JUP/PKP1/TPI1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/TXN/DSP/ALB/GAPDH/LGALS3/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/MIF/SERPINB5/EEF1A1/HIST1H2BK/LDHA/ANXA2/RPSA/GSTP1/SERPINB12/PRDX6/NME2/SERPINB3/TGM3/PKM/LCN1/FGG/HSPA2/SPRR1A/FGB/RAB7A/PSMB6/PSMB4/S100A8/FGA/C1orf68/CAT/PGK1/RPS15A/SLPI/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/PRDX2/HBB/HSPA5/LYZ/AZGP1/TGM1/RPL12/ATP5B/PHGDH/TALDO1/ANXA1/ALDOA/CCT8/ACTN4/GM2A/GGCT/TRIM29/EIF4A1/HP/IVL/SERPINB2/PSMB5/DDX3Y/PSMA2/RNH1/ALDH2/LOR/APOD/GSN/RPS2/ARG1/MDH1/MDH2/AGA/SERPINB13/YOD1/HSP90AA1/LTF/NEU2/AHCY/CTSD/SERPINA12/ALDH9A1/A2M/EEF1G/HNRNPK/HSPD1/TKT/PCBP1/CRABP2/IDE/LY6D +Muc GO:0044238 primary metabolic process 131 131/181 KRT2/KRT17/CSTA/KRT10/FABP5/SPRR2E/HSPB1/HIST1H2AH/PRDX1/ACTB/S100A11/S100A9/JUP/PKP1/TPI1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/TXN/DSP/ALB/GAPDH/LGALS3/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/MIF/SERPINB5/EEF1A1/HIST1H2BK/LDHA/ANXA2/RPSA/GSTP1/SERPINB12/PRDX6/NME2/SERPINB3/TGM3/PKM/LCN1/FGG/HSPA2/SPRR1A/FGB/RAB7A/PSMB6/PSMB4/S100A8/FGA/C1orf68/CAT/PGK1/RPS15A/SLPI/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/KLK5/HSPA5/LYZ/AZGP1/TGM1/RPL12/ATP5B/PHGDH/TALDO1/ANXA1/ALDOA/CCT8/ACTN4/GM2A/TRIM29/EIF4A1/IVL/SERPINB2/PSMB5/DDX3Y/PSMA2/RNH1/ALDH2/CASP14/LOR/APOD/GSN/KLK7/RPS2/ARG1/MDH1/MDH2/AGA/SERPINB13/YOD1/HSP90AA1/LTF/NEU2/AHCY/CTSD/SERPINA12/A2M/EEF1G/HNRNPK/HSPD1/TKT/PCBP1/CRABP2/IDE/LY6D +Muc GO:0044281 small molecule metabolic process 31 31/181 FABP5/TPI1/TXN/GAPDH/HSPA8/ENO1/MIF/LDHA/GSTP1/NME2/PKM/PSMB6/PSMB4/CAT/PGK1/ATP5B/PHGDH/TALDO1/ANXA1/ALDOA/PSMB5/PSMA2/ALDH2/APOD/ARG1/MDH1/MDH2/AHCY/SERPINA12/TKT/CRABP2 +Muc GO:0045730 respiratory burst 0 0/181 +Muc GO:0070085 glycosylation 0 0/181 +Muc GO:0070988 demethylation 0 0/181 +Muc GO:0071704 organic substance metabolic process 134 134/181 KRT2/KRT17/CSTA/KRT10/FABP5/SPRR2E/HSPB1/HIST1H2AH/PRDX1/ACTB/S100A11/S100A9/JUP/PKP1/TPI1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/TXN/DSP/ALB/GAPDH/LGALS3/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/MIF/SERPINB5/EEF1A1/HIST1H2BK/LDHA/ANXA2/RPSA/GSTP1/SERPINB12/PRDX6/NME2/SERPINB3/TGM3/PKM/LCN1/FGG/HSPA2/LCN2/SPRR1A/FGB/RAB7A/PSMB6/PSMB4/S100A8/FGA/C1orf68/CAT/PGK1/RPS15A/SLPI/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/KLK5/HSPA5/LYZ/AZGP1/TGM1/RPL12/ATP5B/PHGDH/TALDO1/ANXA1/ALDOA/CCT8/ACTN4/GM2A/GGCT/TRIM29/EIF4A1/IVL/SERPINB2/PSMB5/DDX3Y/PSMA2/RNH1/ALDH2/CASP14/LOR/APOD/GSN/KLK7/RPS2/ARG1/MDH1/MDH2/AGA/SERPINB13/YOD1/HSP90AA1/LTF/NEU2/AHCY/CTSD/SERPINA12/ALDH9A1/A2M/EEF1G/HNRNPK/HSPD1/TKT/PCBP1/CRABP2/IDE/LY6D +Muc GO:1900872 pentadec-1-ene metabolic process 0 0/181 +Muc GO:1901049 atropine metabolic process 0 0/181 +Muc GO:1901275 tartrate metabolic process 0 0/181 +Muc GO:1901902 tyrocidine metabolic process 0 0/181 +Muc GO:1902421 hydrogen metabolic process 0 0/181 +Muc GO:0001909 leukocyte mediated cytotoxicity 3 3/181 PRDX1/TUBB4B/ARG1 +Muc GO:0031341 regulation of cell killing 2 2/181 GAPDH/ARG1 +Muc GO:0031342 negative regulation of cell killing 0 0/181 +Muc GO:0031343 positive regulation of cell killing 2 2/181 GAPDH/ARG1 +Muc GO:0031640 killing of cells of other organism 8 8/181 DEFA1/DEFA1B/ALB/GAPDH/HIST1H2BK/LYZ/ARG1/LTF +Muc GO:0097278 complement-dependent cytotoxicity 0 0/181 +Muc GO:0001776 leukocyte homeostasis 2 2/181 MIF/ANXA1 +Muc GO:0002200 somatic diversification of immune receptors 1 1/181 HSPD1 +Muc GO:0002252 immune effector process 53 53/181 DEFA1/DEFA1B/FABP5/CALML5/PRDX1/ACTB/S100A11/S100A9/JUP/PKP1/DSP/LGALS3/DYNLL1/HSPA8/MIF/EEF1A1/DSG1/ANXA2/GSTP1/SERPINB12/TUBB4B/PRDX6/NME2/SERPINB3/PKM/LCN2/RAB7A/HRNR/S100A8/CAT/SLPI/EEF2/HBB/KLK5/LYZ/ANXA1/ALDOA/CCT8/FLG2/GM2A/DSC1/HP/PSMA2/GSN/KLK7/VCL/ARG1/AGA/HSP90AA1/LTF/CTSD/A2M/HSPD1 +Muc GO:0002253 activation of immune response 16 16/181 ACTB/S100A9/LGALS3/UBC/FGG/FGB/PSMB6/PSMB4/S100A8/FGA/PSMB5/PSMA2/HSP90AA1/LTF/A2M/HSPD1 +Muc GO:0002262 myeloid cell homeostasis 2 2/181 PRDX1/ANXA1 +Muc GO:0002339 B cell selection 0 0/181 +Muc GO:0002404 antigen sampling in mucosal-associated lymphoid tissue 0 0/181 +Muc GO:0002440 production of molecular mediator of immune response 5 5/181 MIF/KLK5/KLK7/ARG1/HSPD1 +Muc GO:0002507 tolerance induction 0 0/181 +Muc GO:0002520 immune system development 38 38/181 HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/LGALS3/UBC/ANXA2/SERPINB12/NME2/PSMB6/PSMB4/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/ANXA1/PSMB5/PSMA2/LTF/HSPD1/LY6D +Muc GO:0002682 regulation of immune system process 48 48/181 ACTB/S100A9/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/LGALS3/UBC/MIF/NME2/FGG/FGB/PSMB6/PSMB4/S100A8/FGA/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/KLK5/ANXA1/PSMB5/PSMA2/APOD/GSN/KLK7/ARG1/HSP90AA1/LTF/A2M/HSPD1 +Muc GO:0002683 negative regulation of immune system process 23 23/181 HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/LGALS3/MIF/NME2/PSMB4/ANXA1/APOD/ARG1/LTF/A2M +Muc GO:0002684 positive regulation of immune system process 21 21/181 ACTB/S100A9/LGALS3/UBC/MIF/FGG/FGB/PSMB6/PSMB4/S100A8/FGA/KLK5/ANXA1/PSMB5/PSMA2/KLK7/ARG1/HSP90AA1/LTF/A2M/HSPD1 +Muc GO:0006955 immune response 66 66/181 KRT16/DEFA1/DEFA1B/FABP5/CALML5/PRDX1/ACTB/S100A11/S100A9/JUP/PKP1/DSP/GAPDH/LGALS3/DYNLL1/UBC/HSPA8/IL36G/MIF/EEF1A1/HIST1H2BK/DSG1/ANXA2/CAPZA1/GSTP1/SERPINB12/TUBB4B/PRDX6/NME2/SERPINB3/PKM/FGG/LCN2/FGB/RAB7A/PSMB6/HRNR/PSMB4/S100A8/FGA/CAT/SLPI/EEF2/HBB/KLK5/LYZ/ANXA1/ALDOA/CCT8/FLG2/GM2A/DSC1/HP/PSMB5/PSMA2/GSN/KLK7/VCL/ARG1/AGA/HSP90AA1/LTF/AHCY/CTSD/A2M/HSPD1 +Muc GO:0019882 antigen processing and presentation 9 9/181 DYNLL1/CAPZA1/RAB7A/PSMB6/PSMB4/CAPZB/PSMB5/PSMA2/CTSD +Muc GO:0031294 lymphocyte costimulation 0 0/181 +Muc GO:0035172 hemocyte proliferation 0 0/181 +Muc GO:0042386 hemocyte differentiation 0 0/181 +Muc GO:0045058 T cell selection 0 0/181 +Muc GO:0045321 leukocyte activation 50 50/181 DEFA1/DEFA1B/FABP5/CALML5/PRDX1/S100A11/S100A9/JUP/PKP1/DSP/LGALS3/DYNLL1/HSPA8/MIF/EEF1A1/DSG1/ANXA2/GSTP1/SERPINB12/TUBB4B/PRDX6/NME2/SERPINB3/PKM/LCN2/RAB7A/HRNR/S100A8/CAT/SLPI/EEF2/HBB/LYZ/ANXA1/ALDOA/CCT8/FLG2/GM2A/DSC1/HP/PSMA2/GSN/VCL/ARG1/AGA/HSP90AA1/LTF/CTSD/HSPD1/LY6D +Muc GO:0050900 leukocyte migration 8 8/181 DEFA1/DEFA1B/S100A9/LGALS3/MIF/S100A8/ANXA1/APOD +Muc GO:0090713 immunological memory process 0 0/181 +Muc GO:0006792 regulation of sulfur utilization 0 0/181 +Muc GO:0045882 negative regulation of sulfur utilization 0 0/181 +Muc GO:0045883 positive regulation of sulfur utilization 0 0/181 +Muc GO:0006795 regulation of phosphorus utilization 0 0/181 +Muc GO:0045942 negative regulation of phosphorus utilization 0 0/181 +Muc GO:0045949 positive regulation of phosphorus utilization 0 0/181 +Muc GO:0001545 primary ovarian follicle growth 0 0/181 +Muc GO:0001546 preantral ovarian follicle growth 0 0/181 +Muc GO:0001550 ovarian cumulus expansion 0 0/181 +Muc GO:0016049 cell growth 7 7/181 KRT17/S100A9/SFN/ENO1/S100A8/VCL/CRABP2 +Muc GO:0007117 budding cell bud growth 0 0/181 +Muc GO:0030447 filamentous growth 0 0/181 +Muc GO:0040008 regulation of growth 8 8/181 KRT17/S100A9/SFN/ENO1/S100A8/EPPK1/TKT/CRABP2 +Muc GO:0042702 uterine wall growth 0 0/181 +Muc GO:0044110 growth involved in symbiotic interaction 0 0/181 +Muc GO:0045926 negative regulation of growth 1 1/181 ENO1 +Muc GO:0045927 positive regulation of growth 5 5/181 KRT17/S100A9/SFN/S100A8/CRABP2 +Muc GO:0048589 developmental growth 7 7/181 PKM/EPPK1/ANXA1/APOD/GSN/VCL/CRABP2 +Muc GO:0080189 primary growth 0 0/181 +Muc GO:0080190 lateral growth 0 0/181 +Muc GO:0002209 behavioral defense response 1 1/181 VDAC3 +Muc GO:0002210 behavioral response to wounding 0 0/181 +Muc GO:0007611 learning or memory 2 2/181 GM2A/VDAC3 +Muc GO:0007622 rhythmic behavior 1 1/181 AHCY +Muc GO:0007625 grooming behavior 0 0/181 +Muc GO:0007626 locomotory behavior 0 0/181 +Muc GO:0030537 larval behavior 0 0/181 +Muc GO:0007631 feeding behavior 0 0/181 +Muc GO:0007632 visual behavior 0 0/181 +Muc GO:0007635 chemosensory behavior 0 0/181 +Muc GO:0007638 mechanosensory behavior 0 0/181 +Muc GO:0030534 adult behavior 0 0/181 +Muc GO:0019098 reproductive behavior 0 0/181 +Muc GO:0032537 host-seeking behavior 0 0/181 +Muc GO:0035187 hatching behavior 0 0/181 +Muc GO:0035640 exploration behavior 0 0/181 +Muc GO:0040040 thermosensory behavior 0 0/181 +Muc GO:0042630 behavioral response to water deprivation 0 0/181 +Muc GO:0048266 behavioral response to pain 0 0/181 +Muc GO:0048520 positive regulation of behavior 0 0/181 +Muc GO:0048521 negative regulation of behavior 0 0/181 +Muc GO:0050795 regulation of behavior 0 0/181 +Muc GO:0051705 multi-organism behavior 0 0/181 +Muc GO:0051780 behavioral response to nutrient 0 0/181 +Muc GO:0051867 general adaptation syndrome, behavioral process 0 0/181 +Muc GO:0060273 crying behavior 0 0/181 +Muc GO:0060756 foraging behavior 0 0/181 +Muc GO:0061744 motor behavior 0 0/181 +Muc GO:0071625 vocalization behavior 0 0/181 +Muc GO:0001833 inner cell mass cell proliferation 0 0/181 +Muc GO:0001834 trophectodermal cell proliferation 0 0/181 +Muc GO:0002174 mammary stem cell proliferation 0 0/181 +Muc GO:0002941 synoviocyte proliferation 0 0/181 +Muc GO:0003419 growth plate cartilage chondrocyte proliferation 0 0/181 +Muc GO:0008284 positive regulation of cell proliferation 10 10/181 MIF/ANXA2/NCCRP1/NME2/SERPINB3/RPS15A/TGM1/ANXA1/ARG1/LTF +Muc GO:0008285 negative regulation of cell proliferation 8 8/181 S100A11/SFN/GSTP1/EPPK1/AZGP1/LMNA/APOD/ARG1 +Muc GO:0010463 mesenchymal cell proliferation 1 1/181 LMNA +Muc GO:0014009 glial cell proliferation 1 1/181 EEF2 +Muc GO:0033002 muscle cell proliferation 2 2/181 GSTP1/APOD +Muc GO:0033687 osteoblast proliferation 1 1/181 LTF +Muc GO:0035726 common myeloid progenitor cell proliferation 1 1/181 GSTP1 +Muc GO:0035736 cell proliferation involved in compound eye morphogenesis 0 0/181 +Muc GO:0035988 chondrocyte proliferation 1 1/181 LTF +Muc GO:0036093 germ cell proliferation 0 0/181 +Muc GO:0042127 regulation of cell proliferation 20 20/181 S100A11/JUP/SFN/LGALS3/MIF/SERPINB5/ANXA2/NCCRP1/GSTP1/NME2/SERPINB3/EPPK1/RPS15A/AZGP1/TGM1/ANXA1/LMNA/APOD/ARG1/LTF +Muc GO:0044340 canonical Wnt signaling pathway involved in regulation of cell proliferation 0 0/181 +Muc GO:0048134 germ-line cyst formation 0 0/181 +Muc GO:0048144 fibroblast proliferation 3 3/181 MIF/ANXA2/GSTP1 +Muc GO:0050673 epithelial cell proliferation 7 7/181 KRT2/SFN/SERPINB5/NME2/EPPK1/TGM1/ARG1 +Muc GO:0051450 myoblast proliferation 0 0/181 +Muc GO:0060722 cell proliferation involved in embryonic placenta development 0 0/181 +Muc GO:0061323 cell proliferation involved in heart morphogenesis 0 0/181 +Muc GO:0061351 neural precursor cell proliferation 0 0/181 +Muc GO:0070341 fat cell proliferation 0 0/181 +Muc GO:0070661 leukocyte proliferation 6 6/181 LGALS3/MIF/GSTP1/ANXA1/ARG1/HSPD1 +Muc GO:0071335 hair follicle cell proliferation 0 0/181 +Muc GO:0071838 cell proliferation in bone marrow 0 0/181 +Muc GO:0072089 stem cell proliferation 0 0/181 +Muc GO:0072111 cell proliferation involved in kidney development 0 0/181 +Muc GO:0090255 cell proliferation involved in imaginal disc-derived wing morphogenesis 0 0/181 +Muc GO:0097360 chorionic trophoblast cell proliferation 0 0/181 +Muc GO:1990654 sebum secreting cell proliferation 0 0/181 +Muc GO:2000793 cell proliferation involved in heart valve development 0 0/181 +Muc GO:0043610 regulation of carbohydrate utilization 0 0/181 +Muc GO:0007059 chromosome segregation 2 2/181 DYNLL1/DDX3Y +Muc GO:0007017 microtubule-based process 5 5/181 HSPB1/GAPDH/DYNLL1/TUBB4B/LMNA +Muc GO:0000075 cell cycle checkpoint 2 2/181 SFN/UBC +Muc GO:0000920 cell separation after cytokinesis 0 0/181 +Muc GO:0001775 cell activation 57 57/181 KRT2/DEFA1/DEFA1B/FABP5/CALML5/HSPB1/PRDX1/ACTB/S100A11/S100A9/JUP/PKP1/DSP/LGALS3/DYNLL1/YWHAZ/HSPA8/MIF/EEF1A1/DSG1/ANXA2/GSTP1/SERPINB12/TUBB4B/PRDX6/NME2/SERPINB3/PKM/FGG/LCN2/FGB/RAB7A/HRNR/S100A8/FGA/CAT/SLPI/EEF2/HBB/LYZ/ANXA1/ALDOA/CCT8/FLG2/GM2A/DSC1/HP/PSMA2/GSN/VCL/ARG1/AGA/HSP90AA1/LTF/CTSD/HSPD1/LY6D +Muc GO:0010496 intercellular transport 0 0/181 +Muc GO:0006457 protein folding 8 8/181 HSPB1/UBC/HSPA8/HSPA2/HSPA5/CCT8/HSP90AA1/HSPD1 +Muc GO:0007165 signal transduction 69 69/181 KRT17/DEFA1/DEFA1B/CALML5/HSPB1/PRDX1/ACTB/S100A11/S100A9/JUP/PKP1/PFN1/SFN/TXN/LGALS3/DYNLL1/YWHAZ/UBC/ENO1/IL36G/MIF/ANXA2/CAPZA1/GSTP1/NME2/SERPINB3/FGG/LCN2/FGB/KRT18/RAB7A/PSMB6/PSMB4/S100A8/FGA/CAT/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/KLK5/HSPA5/TALDO1/ANXA1/LMNA/ACTN4/GGCT/SERPINB2/PSMB5/PSMA2/APOD/GSN/ARG1/YOD1/HSP90AA1/LTF/SERPINA12/A2M/HNRNPK/HSPD1/FLNB/CRABP2/IDE +Muc GO:0006903 vesicle targeting 0 0/181 +Muc GO:0006276 plasmid maintenance 0 0/181 +Muc GO:0006928 movement of cell or subcellular component 29 29/181 KRT2/KRT16/DEFA1/DEFA1B/HSPB1/ACTB/S100A9/JUP/PFN1/TXN/DSP/LGALS3/DYNLL1/MIF/SERPINB5/CAPZA1/GSTP1/TUBB4B/SERPINB3/S100A8/EPPK1/CAPZB/HSPA5/ATP5B/ANXA1/LMNA/ACTN4/APOD/VCL +Muc GO:0006949 syncytium formation 0 0/181 +Muc GO:0007049 cell cycle 17 17/181 SFN/DYNLL1/UBC/HSPA8/MIF/TUBB4B/HSPA2/KRT18/PSMB6/PSMB4/RPS15A/TGM1/ANXA1/LMNA/PSMB5/PSMA2/HSP90AA1 +Muc GO:0007154 cell communication 73 73/181 KRT17/DEFA1/DEFA1B/CALML5/HSPB1/PRDX1/ACTB/S100A11/S100A9/JUP/PKP1/PFN1/SFN/TXN/DSP/ALB/LGALS3/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/IL36G/MIF/ANXA2/CAPZA1/GSTP1/NME2/SERPINB3/FGG/LCN2/FGB/KRT18/RAB7A/PSMB6/PSMB4/S100A8/FGA/CAT/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/KLK5/HSPA5/TALDO1/ANXA1/LMNA/ACTN4/GGCT/SERPINB2/PSMB5/PSMA2/APOD/GSN/ARG1/YOD1/HSP90AA1/LTF/SERPINA12/A2M/HNRNPK/HSPD1/FLNB/CRABP2/IDE/VDAC3 +Muc GO:0007163 establishment or maintenance of cell polarity 2 2/181 LMNA/GSN +Muc GO:0007272 ensheathment of neurons 0 0/181 +Muc GO:0008219 cell death 70 70/181 KRT2/KRT9/KRT6B/KRT5/KRT16/KRT14/KRT17/CSTA/KRT10/SPRR2E/HSPB1/KRT13/S100A9/JUP/PKP1/SFN/TXN/DSP/ALB/KRT80/KRT3/LGALS7B/GAPDH/LGALS3/DYNLL1/YWHAZ/UBC/KRT79/ENO1/KRT77/MIF/KRT78/LDHA/DSG1/GSTP1/NME2/KRT23/PKM/FGG/LCN2/SPRR1A/FGB/KRT72/KRT18/S100A8/FGA/CAT/PRDX2/GSDMA/HBB/KLK5/HSPA5/TGM1/KRT86/ANXA1/LMNA/ACTN4/GGCT/DSC1/HP/IVL/SERPINB2/CASP14/LOR/GSN/SERPINB13/LTF/CDSN/HNRNPK/HSPD1 +Muc GO:0008037 cell recognition 3 3/181 LGALS3/ALDOA/CCT8 +Muc GO:0019835 cytolysis 2 2/181 ALB/LYZ +Muc GO:0010118 stomatal movement 0 0/181 +Muc GO:0016037 light absorption 0 0/181 +Muc GO:0016043 cellular component organization 99 99/181 KRT2/KRT9/KRT6B/KRT5/KRT16/KRT14/KRT17/HIST1H2AH/ACTB/KRT13/S100A9/JUP/PKP1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/DSP/ALB/KRT3/GAPDH/LGALS3/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/MIF/SERPINB5/HIST1H2BK/DSG1/ANXA2/CAPZA1/RPSA/TUBB4B/NME2/TGM3/PKM/FGG/HSPA2/LCN2/FGB/KRT18/RAB7A/HRNR/S100A8/FGA/EPPK1/CAT/DMKN/CAPZB/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/POF1B/HBB/HSPA5/TGM1/RPL12/ATP5B/ANXA1/ALDOA/LMNA/CCT8/ACTN4/GGCT/LOR/APOD/GSN/KLK7/VCL/ARG1/HSP90AA1/A2M/HNRNPK/HSPD1/FLNB/CRABP2/IDE/VDAC3 +Muc GO:0016458 gene silencing 25 25/181 HIST1H2AH/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H +Muc GO:0019725 cellular homeostasis 14 14/181 PRDX1/S100A9/TXN/UBC/PRDX6/NME2/LCN2/RAB7A/S100A8/PRDX2/ATP5B/ALDOA/LTF/IDE +Muc GO:0022402 cell cycle process 13 13/181 SFN/DYNLL1/UBC/MIF/TUBB4B/HSPA2/PSMB6/PSMB4/ANXA1/LMNA/PSMB5/PSMA2/HSP90AA1 +Muc GO:0022406 membrane docking 4 4/181 DYNLL1/TUBB4B/RAB7A/HSP90AA1 +Muc GO:0022412 cellular process involved in reproduction in multicellular organism 1 1/181 HSPA2 +Muc GO:0030029 actin filament-based process 12 12/181 ACTB/JUP/PFN1/DSP/CAPZA1/CAPZB/POF1B/ANXA1/ALDOA/ACTN4/GSN/FLNB +Muc GO:0032196 transposition 0 0/181 +Muc GO:0032940 secretion by cell 55 55/181 DEFA1/DEFA1B/FABP5/CALML5/S100A11/S100A9/JUP/PKP1/DSP/ALB/GAPDH/LGALS3/DYNLL1/HSPA8/MIF/EEF1A1/DSG1/ANXA2/GSTP1/SERPINB12/TUBB4B/PRDX6/NME2/SERPINB3/PKM/FGG/LCN2/FGB/TAGLN2/RAB7A/HRNR/S100A8/FGA/CAT/SLPI/EEF2/HBB/LYZ/ANXA1/ALDOA/CCT8/ACTN4/FLG2/GM2A/DSC1/HP/PSMA2/GSN/VCL/ARG1/AGA/HSP90AA1/LTF/CTSD/A2M +Muc GO:0033059 cellular pigmentation 0 0/181 +Muc GO:0034337 RNA folding 0 0/181 +Muc GO:0035212 cell competition in a multicellular organism 0 0/181 +Muc GO:0035638 signal maturation 0 0/181 +Muc GO:0036166 phenotypic switching 0 0/181 +Muc GO:0043335 protein unfolding 1 1/181 HSP90AA1 +Muc GO:0044663 establishment or maintenance of cell type involved in phenotypic switching 0 0/181 +Muc GO:0044764 multi-organism cellular process 2 2/181 ALB/LTF +Muc GO:0045103 intermediate filament-based process 10 10/181 KRT2/KRT9/KRT16/KRT14/KRT17/PKP1/DSP/KRT3/KRT18/EPPK1 +Muc GO:0048522 positive regulation of cellular process 56 56/181 KRT17/HSPB1/S100A9/JUP/PFN1/SFN/TXN/GAPDH/LGALS3/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/MIF/LDHA/ANXA2/NCCRP1/GSTP1/PRDX6/NME2/SERPINB3/FGG/HSPA2/LCN2/FGB/RAB7A/PSMB6/PSMB4/S100A8/FGA/CAT/RPS15A/EEF2/HBB/KLK5/HSPA5/TGM1/ATP5B/ANXA1/LMNA/CCT8/ACTN4/HP/PSMB5/PSMA2/GSN/ARG1/HSP90AA1/LTF/SERPINA12/HNRNPK/HSPD1/PCBP1/CRABP2/IDE +Muc GO:0048523 negative regulation of cellular process 87 87/181 KRT16/CSTA/HSPB1/HIST1H2AH/S100A11/PKP1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/TXN/ALB/GAPDH/LGALS3/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/MIF/SERPINB5/ANXA2/CAPZA1/GSTP1/SERPINB12/NME2/SERPINB3/LCN1/FGG/HSPA2/FGB/KRT18/RAB7A/PSMB6/PSMB4/FGA/EPPK1/CAT/SLPI/CAPZB/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/PRDX2/HSPA5/AZGP1/ATP5B/ANXA1/LMNA/ACTN4/TRIM29/HP/SERPINB2/PSMB5/PSMA2/APOD/GSN/VCL/ARG1/SERPINB13/YOD1/LTF/CDSN/SERPINA12/A2M/HNRNPK/HSPD1/IDE +Muc GO:0048869 cellular developmental process 98 98/181 KRT2/KRT9/KRT6B/KRT5/KRT16/KRT14/KRT17/CSTA/KRT10/SPRR2E/KRT13/JUP/PKP1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/DSP/KRT80/KRT3/LGALS3/UBC/KRT79/KRT77/MIF/KRT78/DSG1/ANXA2/GSTP1/SERPINB12/NME2/SERPINB3/TGM3/KRT23/FGG/HSPA2/SPRR1A/FGB/KRT72/TAGLN2/KRT18/PSMB6/HRNR/PSMB4/S100A8/FGA/C1orf68/CAT/PGK1/CAPZB/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/POF1B/KLK5/HSPA5/TGM1/ATP5B/KRT86/ANXA1/ALDOA/LMNA/ACTN4/DSC1/IVL/PSMB5/PSMA2/CASP14/LOR/APOD/GSN/VCL/SERPINB13/LTF/CDSN/A2M/FLNB/CRABP2/LY6D +Muc GO:0050794 regulation of cellular process 118 118/181 KRT16/KRT17/CSTA/DEFA1/DEFA1B/CALML5/HSPB1/HIST1H2AH/PRDX1/ACTB/S100A11/S100A9/JUP/PKP1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/TXN/DSP/ALB/GAPDH/LGALS3/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/IL36G/MIF/SERPINB5/EEF1A1/LDHA/ANXA2/CAPZA1/NCCRP1/GSTP1/SERPINB12/TUBB4B/PRDX6/NME2/SERPINB3/LCN1/FGG/HSPA2/LCN2/FGB/KRT18/RAB7A/PSMB6/PSMB4/S100A8/FGA/EPPK1/CAT/RPS15A/SLPI/CAPZB/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/PRDX2/HBB/KLK5/HSPA5/AZGP1/TGM1/ATP5B/TALDO1/ANXA1/ALDOA/LMNA/CCT8/ACTN4/GGCT/TRIM29/HP/SERPINB2/PSMB5/PSMA2/APOD/GSN/VCL/ARG1/SERPINB13/YOD1/HSP90AA1/LTF/CDSN/SERPINA12/A2M/HNRNPK/HSPD1/FLNB/PCBP1/CRABP2/IDE/VDAC3 +Muc GO:0051301 cell division 2 2/181 SFN/CAT +Muc GO:0051651 maintenance of location in cell 5 5/181 JUP/ALB/HSPA5/GSN/FLNB +Muc GO:0051716 cellular response to stimulus 95 95/181 KRT17/DEFA1/DEFA1B/CALML5/HSPB1/PRDX1/ACTB/KRT13/S100A11/S100A9/JUP/PKP1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/TXN/ALB/GAPDH/LGALS3/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/IL36G/MIF/EEF1A1/ANXA2/CAPZA1/GSTP1/PRDX6/NME2/SERPINB3/PKM/FGG/LCN2/FGB/KRT18/RAB7A/PSMB6/PSMB4/S100A8/FGA/CAT/PGK1/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/PRDX2/HBB/KLK5/HSPA5/TALDO1/ANXA1/LMNA/ACTN4/GGCT/HP/SERPINB2/PSMB5/PSMA2/APOD/GSN/ARG1/YOD1/HSP90AA1/LTF/SERPINA12/A2M/HNRNPK/HSPD1/FLNB/CRABP2/IDE +Muc GO:0060242 contact inhibition 0 0/181 +Muc GO:0060352 cell adhesion molecule production 0 0/181 +Muc GO:0061919 process utilizing autophagic mechanism 12 12/181 HSPB1/S100A9/GAPDH/DYNLL1/UBC/HSPA8/EEF1A1/RAB7A/S100A8/YOD1/HSP90AA1/CTSD +Muc GO:0071554 cell wall organization or biogenesis 1 1/181 LYZ +Muc GO:0071804 cellular potassium ion transport 0 0/181 +Muc GO:0090485 chromosome number maintenance 0 0/181 +Muc GO:0090618 DNA clamp unloading 0 0/181 +Muc GO:0097194 execution phase of apoptosis 1 1/181 CASP14 +Muc GO:0097528 execution phase of necroptosis 0 0/181 +Muc GO:0140029 exocytic process 0 0/181 +Muc GO:0043609 regulation of carbon utilization 0 0/181 +Muc GO:0006808 regulation of nitrogen utilization 0 0/181 +Muc GO:0019676 ammonia assimilation cycle 0 0/181 +Muc GO:0045847 negative regulation of nitrogen utilization 0 0/181 +Muc GO:0045848 positive regulation of nitrogen utilization 0 0/181 +Muc GO:0000728 gene conversion at mating-type locus, DNA double-strand break formation 0 0/181 +Muc GO:0000734 gene conversion at mating-type locus, DNA repair synthesis 0 0/181 +Muc GO:0000742 karyogamy involved in conjugation with cellular fusion 0 0/181 +Muc GO:0000743 nuclear migration involved in conjugation with cellular fusion 0 0/181 +Muc GO:0000749 response to pheromone involved in conjugation with cellular fusion 0 0/181 +Muc GO:0000751 mitotic cell cycle G1 arrest in response to pheromone 0 0/181 +Muc GO:0000754 adaptation of signaling pathway by response to pheromone involved in conjugation with cellular fusion 0 0/181 +Muc GO:0002077 acrosome matrix dispersal 0 0/181 +Muc GO:0003006 developmental process involved in reproduction 3 3/181 SERPINB5/HSPA2/ANXA1 +Muc GO:0007299 ovarian follicle cell-cell adhesion 0 0/181 +Muc GO:0007300 ovarian nurse cell to oocyte transport 0 0/181 +Muc GO:0007303 cytoplasmic transport, nurse cell to oocyte 0 0/181 +Muc GO:0007316 pole plasm RNA localization 0 0/181 +Muc GO:0007318 pole plasm protein localization 0 0/181 +Muc GO:0007340 acrosome reaction 0 0/181 +Muc GO:0007343 egg activation 0 0/181 +Muc GO:0007344 pronuclear fusion 0 0/181 +Muc GO:0007534 gene conversion at mating-type locus 0 0/181 +Muc GO:0007543 sex determination, somatic-gonadal interaction 0 0/181 +Muc GO:0007566 embryo implantation 0 0/181 +Muc GO:0009566 fertilization 2 2/181 ALDOA/CCT8 +Muc GO:0009846 pollen germination 0 0/181 +Muc GO:0009856 pollination 0 0/181 +Muc GO:0009859 pollen hydration 0 0/181 +Muc GO:0009875 pollen-pistil interaction 0 0/181 +Muc GO:0009876 pollen adhesion 0 0/181 +Muc GO:0010069 zygote asymmetric cytokinesis in embryo sac 0 0/181 +Muc GO:0010183 pollen tube guidance 0 0/181 +Muc GO:0010344 seed oilbody biogenesis 0 0/181 +Muc GO:0010588 cotyledon vascular tissue pattern formation 0 0/181 +Muc GO:0010708 heteroduplex formation involved in gene conversion at mating-type locus 0 0/181 +Muc GO:0018985 pronuclear envelope synthesis 0 0/181 +Muc GO:0022413 reproductive process in single-celled organism 0 0/181 +Muc GO:0022602 ovulation cycle process 0 0/181 +Muc GO:0030709 border follicle cell delamination 0 0/181 +Muc GO:0030720 oocyte localization involved in germarium-derived egg chamber formation 0 0/181 +Muc GO:0031292 gene conversion at mating-type locus, DNA double-strand break processing 0 0/181 +Muc GO:0032005 signal transduction involved in conjugation with cellular fusion 0 0/181 +Muc GO:0032219 cell wall macromolecule catabolic process involved in cytogamy 0 0/181 +Muc GO:0032220 plasma membrane fusion involved in cytogamy 0 0/181 +Muc GO:0034624 DNA recombinase assembly involved in gene conversion at mating-type locus 0 0/181 +Muc GO:0034636 strand invasion involved in gene conversion at mating-type locus 0 0/181 +Muc GO:0035036 sperm-egg recognition 2 2/181 ALDOA/CCT8 +Muc GO:0035037 sperm entry 0 0/181 +Muc GO:0035038 female pronucleus assembly 0 0/181 +Muc GO:0035039 male pronucleus assembly 0 0/181 +Muc GO:0035040 sperm nuclear envelope removal 0 0/181 +Muc GO:0035041 sperm chromatin decondensation 0 0/181 +Muc GO:0035042 fertilization, exchange of chromosomal proteins 0 0/181 +Muc GO:0035044 sperm aster formation 0 0/181 +Muc GO:0035046 pronuclear migration 0 0/181 +Muc GO:0043093 FtsZ-dependent cytokinesis 0 0/181 +Muc GO:0044703 multi-organism reproductive process 6 6/181 KRT9/DSG1/HSPA2/ALDOA/CCT8/ARG1 +Muc GO:0045450 bicoid mRNA localization 0 0/181 +Muc GO:0045729 respiratory burst at fertilization 0 0/181 +Muc GO:0046595 establishment of pole plasm mRNA localization 0 0/181 +Muc GO:0048359 mucilage metabolic process involved in seed coat development 0 0/181 +Muc GO:0048497 maintenance of floral organ identity 0 0/181 +Muc GO:0048544 recognition of pollen 0 0/181 +Muc GO:0048573 photoperiodism, flowering 0 0/181 +Muc GO:0048609 multicellular organismal reproductive process 5 5/181 KRT9/DSG1/HSPA2/ANXA1/ARG1 +Muc GO:0051037 regulation of transcription involved in meiotic cell cycle 0 0/181 +Muc GO:0051321 meiotic cell cycle 1 1/181 HSPA2 +Muc GO:0051663 oocyte nucleus localization involved in oocyte dorsal/ventral axis specification 0 0/181 +Muc GO:0060011 Sertoli cell proliferation 0 0/181 +Muc GO:0060466 activation of meiosis involved in egg activation 0 0/181 +Muc GO:0060468 prevention of polyspermy 0 0/181 +Muc GO:0060469 positive regulation of transcription involved in egg activation 0 0/181 +Muc GO:0060470 positive regulation of cytosolic calcium ion concentration involved in egg activation 0 0/181 +Muc GO:0060471 cortical granule exocytosis 0 0/181 +Muc GO:0060474 positive regulation of flagellated sperm motility involved in capacitation 0 0/181 +Muc GO:0060475 positive regulation of actin filament polymerization involved in acrosome reaction 0 0/181 +Muc GO:0060476 protein localization involved in acrosome reaction 0 0/181 +Muc GO:0060478 acrosomal vesicle exocytosis 0 0/181 +Muc GO:0060518 cell migration involved in prostatic bud elongation 0 0/181 +Muc GO:0060519 cell adhesion involved in prostatic bud elongation 0 0/181 +Muc GO:0060673 cell-cell signaling involved in placenta development 0 0/181 +Muc GO:0060710 chorio-allantoic fusion 0 0/181 +Muc GO:0060738 epithelial-mesenchymal signaling involved in prostate gland development 0 0/181 +Muc GO:0060739 mesenchymal-epithelial cell signaling involved in prostate gland development 0 0/181 +Muc GO:0060767 epithelial cell proliferation involved in prostate gland development 0 0/181 +Muc GO:0060781 mesenchymal cell proliferation involved in prostate gland development 0 0/181 +Muc GO:0060783 mesenchymal smoothened signaling pathway involved in prostate gland development 0 0/181 +Muc GO:0060858 vesicle-mediated transport involved in floral organ abscission 0 0/181 +Muc GO:0060869 transmembrane receptor protein serine/threonine kinase signaling pathway involved in floral organ abscission 0 0/181 +Muc GO:0060870 cell wall disassembly involved in floral organ abscission 0 0/181 +Muc GO:0061450 trophoblast cell migration 0 0/181 +Muc GO:0061500 gene conversion at mating-type locus, termination of copy-synthesis 0 0/181 +Muc GO:0061883 clathrin-dependent endocytosis involved in vitellogenesis 0 0/181 +Muc GO:0061948 premature acrosome loss 0 0/181 +Muc GO:0070871 cell wall organization involved in conjugation with cellular fusion 0 0/181 +Muc GO:0070872 plasma membrane organization involved in conjugation with cellular fusion 0 0/181 +Muc GO:0071432 peptide mating pheromone maturation involved in conjugation with cellular fusion 0 0/181 +Muc GO:0071508 activation of MAPK activity involved in conjugation with cellular fusion 0 0/181 +Muc GO:0071509 activation of MAPKK activity involved in conjugation with cellular fusion 0 0/181 +Muc GO:0071510 activation of MAPKKK activity involved in conjugation with cellular fusion 0 0/181 +Muc GO:0071511 inactivation of MAPK activity involved in conjugation with cellular fusion 0 0/181 +Muc GO:0071512 MAPK import into nucleus involved in conjugation with cellular fusion 0 0/181 +Muc GO:0071631 mating pheromone secretion involved in conjugation with cellular fusion 0 0/181 +Muc GO:0071833 peptide pheromone export involved in conjugation with cellular fusion 0 0/181 +Muc GO:0072409 detection of stimulus involved in meiotic cell cycle checkpoint 0 0/181 +Muc GO:0090220 chromosome localization to nuclear envelope involved in homologous chromosome segregation 0 0/181 +Muc GO:1902064 regulation of transcription from RNA polymerase II promoter involved in spermatogenesis 0 0/181 +Muc GO:1902397 detection of stimulus involved in meiotic spindle checkpoint 0 0/181 +Muc GO:1902441 protein localization to meiotic spindle pole body 0 0/181 +Muc GO:1903046 meiotic cell cycle process 1 1/181 HSPA2 +Muc GO:2000241 regulation of reproductive process 0 0/181 +Muc GO:2000242 negative regulation of reproductive process 0 0/181 +Muc GO:2000243 positive regulation of reproductive process 0 0/181 +Muc GO:0007155 cell adhesion 33 33/181 CSTA/HSPB1/ACTB/S100A11/S100A9/JUP/PKP1/DSP/LGALS7B/LGALS3/DSG1/ANXA2/RPSA/NME2/FGG/FGB/KRT18/S100A8/FGA/HBB/AZGP1/ATP5B/ANXA1/ACTN4/TRIM29/DSC1/APOD/GSN/VCL/ARG1/CDSN/HSPD1/LY6D +Muc GO:0022608 multicellular organism adhesion 0 0/181 +Muc GO:0044406 adhesion of symbiont to host 1 1/181 LTF +Muc GO:0090675 intermicrovillar adhesion 0 0/181 +Muc GO:0007267 cell-cell signaling 17 17/181 S100A9/JUP/PFN1/TXN/UBC/HSPA8/IL36G/SERPINB3/FGG/FGB/PSMB6/PSMB4/FGA/ANXA1/PSMB5/PSMA2/VDAC3 +Muc GO:0021807 motogenic signaling initiating cell movement in cerebral cortex 0 0/181 +Muc GO:0021837 motogenic signaling involved in postnatal olfactory bulb interneuron migration 0 0/181 +Muc GO:0021838 motogenic signaling involved in interneuron migration from the subpallium to the cortex 0 0/181 +Muc GO:0023051 regulation of signaling 39 39/181 HSPB1/PRDX1/S100A9/JUP/SFN/TXN/LGALS3/DYNLL1/YWHAZ/UBC/ENO1/IL36G/MIF/ANXA2/GSTP1/SERPINB3/FGG/FGB/RAB7A/PSMB6/PSMB4/S100A8/FGA/CAT/KLK5/HSPA5/ANXA1/LMNA/ACTN4/PSMB5/PSMA2/APOD/GSN/ARG1/LTF/SERPINA12/A2M/HNRNPK/CRABP2 +Muc GO:0023056 positive regulation of signaling 23 23/181 S100A9/JUP/SFN/TXN/DYNLL1/YWHAZ/UBC/MIF/ANXA2/FGG/FGB/PSMB6/PSMB4/S100A8/FGA/CAT/KLK5/ACTN4/PSMB5/PSMA2/GSN/LTF/SERPINA12 +Muc GO:0023057 negative regulation of signaling 20 20/181 HSPB1/LGALS3/UBC/ENO1/MIF/GSTP1/SERPINB3/FGG/FGB/RAB7A/PSMB6/PSMB4/FGA/HSPA5/LMNA/PSMB5/PSMA2/APOD/ARG1/LTF +Muc GO:0035636 multi-organism signaling 0 0/181 +Muc GO:0035426 extracellular matrix-cell signaling 0 0/181 +Muc GO:0035637 multicellular organismal signaling 2 2/181 JUP/DSP +Muc GO:0001503 ossification 3 3/181 CAT/ATP5B/LTF +Muc GO:0001763 morphogenesis of a branching structure 0 0/181 +Muc GO:0001816 cytokine production 12 12/181 HSPB1/S100A9/GAPDH/UBC/MIF/GSTP1/S100A8/ANXA1/APOD/ARG1/LTF/HSPD1 +Muc GO:0002021 response to dietary excess 0 0/181 +Muc GO:0002532 production of molecular mediator involved in inflammatory response 1 1/181 APOD +Muc GO:0003008 system process 16 16/181 JUP/DSP/ENO1/LCN1/FGG/FGB/FGA/EEF2/HBB/AZGP1/ALDOA/LMNA/GM2A/GSN/VCL/VDAC3 +Muc GO:0003053 circadian regulation of heart rate 0 0/181 +Muc GO:0007275 multicellular organism development 102 102/181 KRT2/KRT9/KRT6B/KRT5/KRT16/KRT14/KRT17/CSTA/KRT10/SPRR2E/HSPB1/PRDX1/ACTB/KRT13/JUP/PKP1/TPI1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/DSP/KRT80/KRT3/LGALS3/DYNLL1/UBC/KRT79/KRT77/SERPINB5/KRT78/LDHA/DSG1/ANXA2/GSTP1/SERPINB12/NME2/SERPINB3/TGM3/KRT23/PKM/SPRR1A/KRT72/KRT18/PSMB6/HRNR/PSMB4/S100A8/C1orf68/CAT/PGK1/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/KLK5/HSPA5/TGM1/ATP5B/PHGDH/KRT86/ANXA1/LMNA/FLG2/DSC1/IVL/PSMB5/PSMA2/RNH1/CASP14/LOR/APOD/GSN/VCL/ARG1/SERPINB13/LTF/CDSN/HSPD1/FLNB/CRABP2/IDE/LY6D +Muc GO:0007389 pattern specification process 0 0/181 +Muc GO:0007585 respiratory gaseous exchange 0 0/181 +Muc GO:0007586 digestion 0 0/181 +Muc GO:0008340 determination of adult lifespan 1 1/181 IDE +Muc GO:0009561 megagametogenesis 0 0/181 +Muc GO:0009791 post-embryonic development 0 0/181 +Muc GO:0009845 seed germination 0 0/181 +Muc GO:0010022 meristem determinacy 0 0/181 +Muc GO:0010073 meristem maintenance 0 0/181 +Muc GO:0010162 seed dormancy process 0 0/181 +Muc GO:0010232 vascular transport 0 0/181 +Muc GO:0016203 muscle attachment 0 0/181 +Muc GO:0019827 stem cell population maintenance 0 0/181 +Muc GO:0022004 midbrain-hindbrain boundary maturation during brain development 0 0/181 +Muc GO:0022005 midbrain-hindbrain boundary maturation during neural plate development 0 0/181 +Muc GO:0022404 molting cycle process 2 2/181 KRT17/TGM3 +Muc GO:0030431 sleep 0 0/181 +Muc GO:0030588 pseudocleavage 0 0/181 +Muc GO:0031424 keratinization 35 35/181 KRT2/KRT9/KRT6B/KRT5/KRT16/KRT14/KRT17/CSTA/KRT10/SPRR2E/KRT13/JUP/PKP1/SFN/DSP/KRT80/KRT3/KRT79/KRT77/KRT78/DSG1/TGM3/KRT23/SPRR1A/KRT72/KRT18/HRNR/KLK5/TGM1/KRT86/DSC1/IVL/CASP14/LOR/CDSN +Muc GO:0032898 neurotrophin production 0 0/181 +Muc GO:0032922 circadian regulation of gene expression 0 0/181 +Muc GO:0032941 secretion by tissue 0 0/181 +Muc GO:0033555 multicellular organismal response to stress 1 1/181 VDAC3 +Muc GO:0034381 plasma lipoprotein particle clearance 2 2/181 ANXA2/HNRNPK +Muc GO:0035073 pupariation 0 0/181 +Muc GO:0035074 pupation 0 0/181 +Muc GO:0035264 multicellular organism growth 0 0/181 +Muc GO:0035265 organ growth 0 0/181 +Muc GO:0035314 scab formation 0 0/181 +Muc GO:0035889 otolith tethering 0 0/181 +Muc GO:0036363 transforming growth factor beta activation 0 0/181 +Muc GO:0042303 molting cycle 4 4/181 KRT16/KRT14/KRT17/TGM3 +Muc GO:0043480 pigment accumulation in tissues 0 0/181 +Muc GO:0044266 multicellular organismal macromolecule catabolic process 0 0/181 +Muc GO:0044274 multicellular organismal biosynthetic process 0 0/181 +Muc GO:0044706 multi-multicellular organism process 2 2/181 DSG1/ARG1 +Muc GO:0045494 photoreceptor cell maintenance 0 0/181 +Muc GO:0048647 polyphenic determination 0 0/181 +Muc GO:0048771 tissue remodeling 3 3/181 RAB7A/ANXA1/ARG1 +Muc GO:0048871 multicellular organismal homeostasis 13 13/181 KRT16/HSPB1/PRDX1/ACTB/SFN/ALB/LCN1/RAB7A/HRNR/LYZ/AZGP1/FLG2/LTF +Muc GO:0050817 coagulation 23 23/181 HSPB1/ACTB/YWHAZ/ANXA2/CAPZA1/FGG/FGB/FGA/CAPZB/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/HBB/SERPINB2/VCL/A2M +Muc GO:0050879 multicellular organismal movement 1 1/181 EEF2 +Muc GO:0051239 regulation of multicellular organismal process 62 62/181 KRT17/HSPB1/JUP/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/DSP/GAPDH/LGALS3/UBC/ENO1/MIF/ANXA2/GSTP1/NME2/SERPINB3/FGG/FGB/PSMB6/PSMB4/FGA/EPPK1/PGK1/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/HSPA5/ATP5B/ANXA1/LMNA/SERPINB2/PSMB5/PSMA2/RNH1/APOD/ARG1/SERPINB13/LTF/CDSN/HNRNPK/HSPD1/CRABP2 +Muc GO:0051240 positive regulation of multicellular organismal process 18 18/181 KRT17/HSPB1/PFN1/GAPDH/ENO1/MIF/ANXA2/NME2/SERPINB3/FGG/FGB/FGA/HSPA5/ATP5B/ANXA1/LTF/HSPD1/CRABP2 +Muc GO:0051241 negative regulation of multicellular organismal process 30 30/181 HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/UBC/ANXA2/GSTP1/NME2/FGG/FGB/FGA/EPPK1/PGK1/ANXA1/LMNA/SERPINB2/APOD/ARG1/LTF/CDSN +Muc GO:0055046 microgametogenesis 0 0/181 +Muc GO:0055127 vibrational conductance of sound to the inner ear 0 0/181 +Muc GO:0060384 innervation 0 0/181 +Muc GO:0071684 organism emergence from protective structure 0 0/181 +Muc GO:0071827 plasma lipoprotein particle organization 1 1/181 ALB +Muc GO:0090130 tissue migration 6 6/181 KRT2/KRT16/HSPB1/PFN1/EPPK1/ATP5B +Muc GO:0090664 response to high population density 0 0/181 +Muc GO:0097167 circadian regulation of translation 0 0/181 +Muc GO:0097207 bud dormancy process 0 0/181 +Muc GO:0097242 amyloid-beta clearance 1 1/181 IDE +Muc GO:1990110 callus formation 0 0/181 +Muc GO:0009653 anatomical structure morphogenesis 34 34/181 KRT16/KRT17/HSPB1/KRT13/PFN1/DSP/UBC/SERPINB5/ANXA2/TGM3/FGG/FGB/KRT18/PSMB6/PSMB4/FGA/PGK1/CAPZB/POF1B/HSPA5/ATP5B/ANXA1/ALDOA/ACTN4/PSMB5/PSMA2/RNH1/APOD/VCL/ARG1/LTF/CDSN/FLNB/CRABP2 +Muc GO:0007568 aging 10 10/181 KRT16/KRT14/MIF/CAT/EEF2/LMNA/APOD/GSN/ARG1/IDE +Muc GO:0007571 age-dependent general metabolic decline 0 0/181 +Muc GO:0009838 abscission 0 0/181 +Muc GO:0009847 spore germination 0 0/181 +Muc GO:0010014 meristem initiation 0 0/181 +Muc GO:0048646 anatomical structure formation involved in morphogenesis 7 7/181 HSPB1/PFN1/ANXA2/PGK1/ATP5B/RNH1/APOD +Muc GO:0021700 developmental maturation 2 2/181 FGG/LTF +Muc GO:0022611 dormancy process 0 0/181 +Muc GO:0031128 developmental induction 0 0/181 +Muc GO:0097737 acquisition of mycelium reproductive competence 0 0/181 +Muc GO:0043696 dedifferentiation 0 0/181 +Muc GO:0043934 sporulation 0 0/181 +Muc GO:0044111 development involved in symbiotic interaction 1 1/181 ANXA2 +Muc GO:0048532 anatomical structure arrangement 1 1/181 HSPA5 +Muc GO:0048856 anatomical structure development 115 115/181 KRT2/KRT9/KRT6B/KRT5/KRT16/KRT14/KRT17/CSTA/KRT10/FABP5/CALML5/SPRR2E/HSPB1/PRDX1/ACTB/KRT13/JUP/PKP1/TPI1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/DSP/KRT80/KRT3/LGALS3/DYNLL1/UBC/KRT79/KRT77/SERPINB5/KRT78/LDHA/DSG1/ANXA2/GSTP1/SERPINB12/NME2/SERPINB3/TGM3/KRT23/PKM/FGG/HSPA2/SPRR1A/FGB/KRT72/TAGLN2/KRT18/PSMB6/HRNR/PSMB4/S100A8/FGA/EPPK1/C1orf68/CAT/PGK1/CAPZB/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/POF1B/KLK5/HSPA5/TGM1/ATP5B/PHGDH/KRT86/ANXA1/ALDOA/LMNA/ACTN4/FLG2/DSC1/IVL/PSMB5/PSMA2/RNH1/CASP14/LOR/APOD/GSN/KLK7/VCL/ARG1/SERPINB13/LTF/CDSN/HSPD1/FLNB/CRABP2/IDE/LY6D +Muc GO:0050793 regulation of developmental process 54 54/181 KRT17/HSPB1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/LGALS3/UBC/MIF/ANXA2/NME2/SERPINB3/FGG/FGB/PSMB6/PSMB4/FGA/EPPK1/PGK1/CAPZB/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/HSPA5/ANXA1/ALDOA/LMNA/ACTN4/PSMB5/PSMA2/RNH1/SERPINB13/LTF/CDSN/CRABP2 +Muc GO:0051093 negative regulation of developmental process 22 22/181 HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/MIF/ANXA2/NME2/PGK1/ANXA1/ACTN4/LTF/CDSN +Muc GO:0051094 positive regulation of developmental process 13 13/181 KRT17/HSPB1/SFN/NME2/SERPINB3/FGG/FGB/FGA/HSPA5/ANXA1/LMNA/LTF/CRABP2 +Muc GO:0060033 anatomical structure regression 0 0/181 +Muc GO:0090644 age-related resistance 0 0/181 +Muc GO:0098727 maintenance of cell number 0 0/181 +Muc GO:0031987 locomotion involved in locomotory behavior 0 0/181 +Muc GO:0033058 directional locomotion 0 0/181 +Muc GO:0036268 swimming 0 0/181 +Muc GO:0040012 regulation of locomotion 15 15/181 KRT16/HSPB1/PFN1/LGALS3/MIF/GSTP1/SERPINB3/EPPK1/HSPA5/ATP5B/ANXA1/LMNA/ACTN4/APOD/VCL +Muc GO:0040013 negative regulation of locomotion 6 6/181 KRT16/MIF/GSTP1/EPPK1/APOD/VCL +Muc GO:0040017 positive regulation of locomotion 7 7/181 HSPB1/PFN1/LGALS3/SERPINB3/HSPA5/ATP5B/ACTN4 +Muc GO:0042330 taxis 9 9/181 DEFA1/DEFA1B/HSPB1/S100A9/LGALS3/MIF/GSTP1/S100A8/ANXA1 +Muc GO:0048870 cell motility 21 21/181 KRT2/KRT16/DEFA1/DEFA1B/HSPB1/S100A9/JUP/PFN1/LGALS3/MIF/GSTP1/SERPINB3/S100A8/EPPK1/HSPA5/ATP5B/ANXA1/LMNA/ACTN4/APOD/VCL +Muc GO:0051821 dissemination or transmission of organism from other organism involved in symbiotic interaction 0 0/181 +Muc GO:0052192 movement in environment of other organism involved in symbiotic interaction 1 1/181 RAB7A +Muc GO:0060361 flight 0 0/181 +Muc GO:0071965 multicellular organismal locomotion 0 0/181 +Muc GO:0033060 ocellus pigmentation 0 0/181 +Muc GO:0043474 pigment metabolic process involved in pigmentation 0 0/181 +Muc GO:0043476 pigment accumulation 0 0/181 +Muc GO:0048066 developmental pigmentation 0 0/181 +Muc GO:0022403 cell cycle phase 0 0/181 +Muc GO:0022601 menstrual cycle phase 0 0/181 +Muc GO:0044851 hair cycle phase 0 0/181 +Muc GO:0060206 estrous cycle phase 0 0/181 +Muc GO:0072690 single-celled organism vegetative growth phase 0 0/181 +Muc GO:0007623 circadian rhythm 1 1/181 AHCY +Muc GO:0007624 ultradian rhythm 0 0/181 +Muc GO:0042698 ovulation cycle 1 1/181 ANXA1 +Muc GO:0032846 positive regulation of homeostatic process 2 2/181 ANXA1/CCT8 +Muc GO:0042753 positive regulation of circadian rhythm 0 0/181 +Muc GO:0043902 positive regulation of multi-organism process 8 8/181 PFN1/GAPDH/HSPA8/MIF/RAB7A/KLK5/KLK7/ARG1 +Muc GO:0044089 positive regulation of cellular component biogenesis 5 5/181 PFN1/DYNLL1/RAB7A/GSN/IDE +Muc GO:0045760 positive regulation of action potential 0 0/181 +Muc GO:0045785 positive regulation of cell adhesion 5 5/181 FGG/FGB/FGA/ANXA1/HSPD1 +Muc GO:0048087 positive regulation of developmental pigmentation 0 0/181 +Muc GO:0048584 positive regulation of response to stimulus 31 31/181 HSPB1/ACTB/S100A9/JUP/SFN/TXN/LGALS3/DYNLL1/YWHAZ/UBC/MIF/FGG/FGB/PSMB6/PSMB4/S100A8/FGA/CAT/KLK5/ANXA1/ACTN4/PSMB5/PSMA2/GSN/KLK7/ARG1/HSP90AA1/LTF/SERPINA12/A2M/HSPD1 +Muc GO:0051050 positive regulation of transport 17 17/181 JUP/SFN/GAPDH/LGALS3/DYNLL1/YWHAZ/MIF/ANXA2/FGG/HSPA2/FGB/RAB7A/S100A8/FGA/ANXA1/ACTN4/HNRNPK +Muc GO:0051091 positive regulation of DNA binding transcription factor activity 6 6/181 S100A9/JUP/UBC/S100A8/CAT/LTF +Muc GO:0051919 positive regulation of fibrinolysis 0 0/181 +Muc GO:0060301 positive regulation of cytokine activity 0 0/181 +Muc GO:1900048 positive regulation of hemostasis 0 0/181 +Muc GO:1900097 positive regulation of dosage compensation by inactivation of X chromosome 0 0/181 +Muc GO:1900454 positive regulation of long term synaptic depression 0 0/181 +Muc GO:1902474 positive regulation of protein localization to synapse 0 0/181 +Muc GO:1902632 positive regulation of membrane hyperpolarization 0 0/181 +Muc GO:1902685 positive regulation of receptor localization to synapse 0 0/181 +Muc GO:1903549 positive regulation of growth hormone activity 0 0/181 +Muc GO:1903666 positive regulation of asexual reproduction 0 0/181 +Muc GO:1903829 positive regulation of cellular protein localization 5 5/181 JUP/SFN/DYNLL1/YWHAZ/CCT8 +Muc GO:1904181 positive regulation of membrane depolarization 0 0/181 +Muc GO:1904582 positive regulation of intracellular mRNA localization 0 0/181 +Muc GO:1904704 positive regulation of protein localization to cell-cell adherens junction 0 0/181 +Muc GO:1904874 positive regulation of telomerase RNA localization to Cajal body 1 1/181 CCT8 +Muc GO:1904912 positive regulation of establishment of RNA localization to telomere 0 0/181 +Muc GO:1904915 positive regulation of establishment of macromolecular complex localization to telomere 0 0/181 +Muc GO:1904951 positive regulation of establishment of protein localization 10 10/181 JUP/SFN/GAPDH/DYNLL1/YWHAZ/MIF/FGG/FGB/FGA/CCT8 +Muc GO:1905099 positive regulation of guanyl-nucleotide exchange factor activity 0 0/181 +Muc GO:1905339 positive regulation of cohesin unloading 0 0/181 +Muc GO:1905514 positive regulation of short-term synaptic potentiation 0 0/181 +Muc GO:1905605 positive regulation of maintenance of permeability of blood-brain barrier 0 0/181 +Muc GO:1905954 positive regulation of lipid localization 2 2/181 MIF/ANXA2 +Muc GO:2000199 positive regulation of ribonucleoprotein complex localization 0 0/181 +Muc GO:2000327 positive regulation of ligand-dependent nuclear receptor transcription coactivator activity 0 0/181 +Muc GO:0008588 release of cytoplasmic sequestered NF-kappaB 0 0/181 +Muc GO:0034260 negative regulation of GTPase activity 0 0/181 +Muc GO:0032845 negative regulation of homeostatic process 1 1/181 MIF +Muc GO:0042754 negative regulation of circadian rhythm 0 0/181 +Muc GO:0043433 negative regulation of DNA binding transcription factor activity 1 1/181 CAT +Muc GO:0043901 negative regulation of multi-organism process 4 4/181 ANXA2/SLPI/GSN/LTF +Muc GO:0045759 negative regulation of action potential 0 0/181 +Muc GO:0048086 negative regulation of developmental pigmentation 0 0/181 +Muc GO:0048585 negative regulation of response to stimulus 27 27/181 HSPB1/TXN/LGALS3/UBC/ENO1/MIF/ANXA2/GSTP1/SERPINB3/FGG/FGB/RAB7A/PSMB6/PSMB4/FGA/EPPK1/HSPA5/ANXA1/LMNA/SERPINB2/PSMB5/PSMA2/APOD/ARG1/YOD1/LTF/A2M +Muc GO:0051051 negative regulation of transport 6 6/181 TXN/LGALS3/RAB7A/ANXA1/APOD/YOD1 +Muc GO:0051918 negative regulation of fibrinolysis 0 0/181 +Muc GO:0060302 negative regulation of cytokine activity 0 0/181 +Muc GO:1900047 negative regulation of hemostasis 5 5/181 ANXA2/FGG/FGB/FGA/SERPINB2 +Muc GO:1900096 negative regulation of dosage compensation by inactivation of X chromosome 0 0/181 +Muc GO:1900272 negative regulation of long-term synaptic potentiation 0 0/181 +Muc GO:1900453 negative regulation of long term synaptic depression 0 0/181 +Muc GO:1902631 negative regulation of membrane hyperpolarization 0 0/181 +Muc GO:1902684 negative regulation of receptor localization to synapse 0 0/181 +Muc GO:1902886 negative regulation of proteasome-activating ATPase activity 0 0/181 +Muc GO:1903548 negative regulation of growth hormone activity 0 0/181 +Muc GO:1903665 negative regulation of asexual reproduction 0 0/181 +Muc GO:1903828 negative regulation of cellular protein localization 4 4/181 TXN/TRIM29/APOD/YOD1 +Muc GO:1904180 negative regulation of membrane depolarization 0 0/181 +Muc GO:1904537 negative regulation of mitotic telomere tethering at nuclear periphery 0 0/181 +Muc GO:1904581 negative regulation of intracellular mRNA localization 0 0/181 +Muc GO:1904703 negative regulation of protein localization to cell-cell adherens junction 0 0/181 +Muc GO:1904873 negative regulation of telomerase RNA localization to Cajal body 0 0/181 +Muc GO:1904911 negative regulation of establishment of RNA localization to telomere 0 0/181 +Muc GO:1904914 negative regulation of establishment of macromolecular complex localization to telomere 0 0/181 +Muc GO:1904950 negative regulation of establishment of protein localization 4 4/181 TXN/ANXA1/APOD/YOD1 +Muc GO:1905098 negative regulation of guanyl-nucleotide exchange factor activity 0 0/181 +Muc GO:1905338 negative regulation of cohesin unloading 0 0/181 +Muc GO:1905385 negative regulation of protein localization to presynapse 0 0/181 +Muc GO:1905513 negative regulation of short-term synaptic potentiation 0 0/181 +Muc GO:1905604 negative regulation of maintenance of permeability of blood-brain barrier 0 0/181 +Muc GO:1905869 negative regulation of 3'-UTR-mediated mRNA stabilization 0 0/181 +Muc GO:1905953 negative regulation of lipid localization 0 0/181 +Muc GO:2000198 negative regulation of ribonucleoprotein complex localization 0 0/181 +Muc GO:2000326 negative regulation of ligand-dependent nuclear receptor transcription coactivator activity 0 0/181 +Muc GO:0030155 regulation of cell adhesion 12 12/181 LGALS3/FGG/FGB/FGA/ATP5B/ANXA1/ACTN4/APOD/GSN/ARG1/CDSN/HSPD1 +Muc GO:0032844 regulation of homeostatic process 3 3/181 MIF/ANXA1/CCT8 +Muc GO:0032879 regulation of localization 38 38/181 KRT16/HSPB1/PRDX1/JUP/PFN1/SFN/TXN/DSP/GAPDH/LGALS3/DYNLL1/YWHAZ/HSPA8/MIF/ANXA2/GSTP1/SERPINB3/FGG/HSPA2/FGB/RAB7A/S100A8/FGA/EPPK1/HSPA5/ATP5B/ANXA1/LMNA/CCT8/ACTN4/TRIM29/APOD/GSN/VCL/ARG1/YOD1/HNRNPK/VDAC3 +Muc GO:0042752 regulation of circadian rhythm 0 0/181 +Muc GO:0043900 regulation of multi-organism process 12 12/181 PFN1/GAPDH/HSPA8/MIF/ANXA2/RAB7A/SLPI/KLK5/GSN/KLK7/ARG1/LTF +Muc GO:0044087 regulation of cellular component biogenesis 12 12/181 PFN1/DYNLL1/HSPA8/CAPZA1/HSPA2/RAB7A/CAPZB/APOD/GSN/HSP90AA1/IDE/VDAC3 +Muc GO:0048070 regulation of developmental pigmentation 0 0/181 +Muc GO:0048518 positive regulation of biological process 84 84/181 KRT17/HSPB1/ACTB/S100A9/JUP/PKP1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/TXN/GAPDH/LGALS3/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/MIF/LDHA/ANXA2/NCCRP1/GSTP1/PRDX6/NME2/SERPINB3/FGG/HSPA2/LCN2/FGB/RAB7A/PSMB6/PSMB4/S100A8/FGA/CAT/RPS15A/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/HBB/KLK5/HSPA5/TGM1/ATP5B/ANXA1/LMNA/CCT8/ACTN4/HP/PSMB5/PSMA2/GSN/KLK7/ARG1/HSP90AA1/LTF/SERPINA12/A2M/HNRNPK/HSPD1/PCBP1/CRABP2/IDE +Muc GO:0048519 negative regulation of biological process 94 94/181 KRT16/CSTA/HSPB1/HIST1H2AH/S100A11/PKP1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/TXN/ALB/GAPDH/LGALS3/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/MIF/SERPINB5/ANXA2/CAPZA1/RPSA/GSTP1/SERPINB12/NME2/SERPINB3/LCN1/FGG/HSPA2/FGB/KRT18/RAB7A/PSMB6/PSMB4/FGA/EPPK1/CAT/PGK1/RPS15A/SLPI/CAPZB/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/PRDX2/HSPA5/AZGP1/RPL12/ATP5B/ANXA1/LMNA/ACTN4/TRIM29/EIF4A1/HP/SERPINB2/PSMB5/PSMA2/RNH1/APOD/GSN/VCL/RPS2/ARG1/SERPINB13/YOD1/LTF/CDSN/SERPINA12/A2M/HNRNPK/HSPD1/IDE +Muc GO:0048583 regulation of response to stimulus 47 47/181 HSPB1/PRDX1/ACTB/S100A9/JUP/SFN/TXN/LGALS3/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/IL36G/MIF/ANXA2/GSTP1/SERPINB3/FGG/FGB/RAB7A/PSMB6/PSMB4/S100A8/FGA/EPPK1/CAT/KLK5/HSPA5/ANXA1/LMNA/ACTN4/SERPINB2/PSMB5/PSMA2/APOD/GSN/KLK7/ARG1/YOD1/HSP90AA1/LTF/SERPINA12/A2M/HNRNPK/HSPD1/CRABP2 +Muc GO:0071898 regulation of estrogen receptor binding 0 0/181 +Muc GO:0097006 regulation of plasma lipoprotein particle levels 3 3/181 ALB/ANXA2/HNRNPK +Muc GO:0098900 regulation of action potential 2 2/181 JUP/DSP +Muc GO:1900046 regulation of hemostasis 5 5/181 ANXA2/FGG/FGB/FGA/SERPINB2 +Muc GO:1902630 regulation of membrane hyperpolarization 0 0/181 +Muc GO:1903664 regulation of asexual reproduction 0 0/181 +Muc GO:1905097 regulation of guanyl-nucleotide exchange factor activity 0 0/181 +Muc GO:1905603 regulation of maintenance of permeability of blood-brain barrier 0 0/181 +Muc GO:0006950 response to stress 92 92/181 KRT16/DEFA1/DEFA1B/HSPB1/PRDX1/ACTB/S100A9/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/TXN/DSP/ALB/GAPDH/LGALS3/YWHAZ/UBC/HSPA8/ENO1/IL36G/MIF/HIST1H2BK/LDHA/ANXA2/CAPZA1/GSTP1/TUBB4B/PRDX6/NME2/SERPINB3/PKM/FGG/HSPA2/LCN2/FGB/PSMB6/PSMB4/S100A8/FGA/EPPK1/CAT/PGK1/SLPI/CAPZB/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/PRDX2/HBB/KLK5/HSPA5/LYZ/ANXA1/LMNA/ACTN4/HP/SERPINB2/PSMB5/PSMA2/APOD/GSN/KLK7/VCL/ARG1/YOD1/HSP90AA1/LTF/AHCY/A2M/HNRNPK/HSPD1/VDAC3 +Muc GO:0009605 response to external stimulus 42 42/181 DEFA1/DEFA1B/HSPB1/S100A9/JUP/ALB/GAPDH/LGALS3/HSPA8/ENO1/MIF/HIST1H2BK/LDHA/ANXA2/GSTP1/PKM/FGG/LCN2/FGB/PSMB4/S100A8/FGA/EPPK1/CAT/RPS15A/SLPI/EEF2/KLK5/HSPA5/LYZ/ANXA1/HP/SERPINB2/PSMA2/APOD/GSN/KLK7/ARG1/LTF/AHCY/A2M/EEF1G +Muc GO:0009607 response to biotic stimulus 25 25/181 DEFA1/DEFA1B/HSPB1/S100A9/GAPDH/ENO1/MIF/HIST1H2BK/GSTP1/LCN2/FGB/S100A8/FGA/RPS15A/SLPI/KLK5/HSPA5/LYZ/HP/PSMA2/KLK7/ARG1/LTF/EEF1G/HSPD1 +Muc GO:0009628 response to abiotic stimulus 25 25/181 KRT14/KRT13/JUP/TXN/UBC/HSPA8/ENO1/LDHA/PKM/HSPA2/PSMB6/PSMB4/CAT/PGK1/HSPA5/ANXA1/LMNA/ACTN4/IVL/PSMB5/PSMA2/SERPINB13/HSP90AA1/AHCY/HSPD1 +Muc GO:0009719 response to endogenous stimulus 18 18/181 DEFA1/DEFA1B/JUP/UBC/EEF1A1/DSG1/ANXA2/GSTP1/NME2/PKM/FGB/CAT/EEF2/HSPA5/ANXA1/ARG1/SERPINA12/IDE +Muc GO:0014823 response to activity 1 1/181 CAT +Muc GO:0014854 response to inactivity 2 2/181 PKM/CAT +Muc GO:0014874 response to stimulus involved in regulation of muscle adaptation 0 0/181 +Muc GO:0042221 response to chemical 72 72/181 KRT14/DEFA1/DEFA1B/HSPB1/PRDX1/KRT13/S100A9/JUP/PFN1/TXN/ALB/GAPDH/LGALS3/UBC/HSPA8/ENO1/IL36G/MIF/EEF1A1/LDHA/DSG1/ANXA2/CAPZA1/GSTP1/PRDX6/NME2/PKM/FGG/HSPA2/LCN2/FGB/KRT18/PSMB6/PSMB4/S100A8/FGA/CAT/PGK1/SLPI/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/PRDX2/HBB/HSPA5/AZGP1/TALDO1/ANXA1/LMNA/HP/SERPINB2/PSMB5/PSMA2/APOD/GSN/ARG1/YOD1/HSP90AA1/LTF/AHCY/SERPINA12/HSPD1/IDE/LY6D +Muc GO:0043500 muscle adaptation 2 2/181 LMNA/GSN +Muc GO:0043627 response to estrogen 1 1/181 LDHA +Muc GO:0051606 detection of stimulus 3 3/181 JUP/UBC/AZGP1 +Muc GO:0051775 response to redox state 0 0/181 +Muc GO:0072376 protein activation cascade 4 4/181 FGG/FGB/FGA/A2M +Muc GO:0032187 actomyosin contractile ring localization 0 0/181 +Muc GO:0033036 macromolecule localization 39 39/181 HSPB1/PRDX1/JUP/SFN/TXN/DSP/ALB/GAPDH/DYNLL1/YWHAZ/HSPA8/MIF/ANXA2/RPSA/LCN1/FGG/FGB/KRT18/RAB7A/FGA/RPS15A/HSPA5/AZGP1/RPL12/ANXA1/LMNA/CCT8/ACTN4/GM2A/TRIM29/APOD/GSN/VCL/RPS2/YOD1/HSP90AA1/HNRNPK/HSPD1/FLNB +Muc GO:0035732 nitric oxide storage 1 1/181 GSTP1 +Muc GO:0051234 establishment of localization 84 84/181 DEFA1/DEFA1B/FABP5/CALML5/HSPB1/PRDX1/ACTB/S100A11/S100A9/JUP/PKP1/SFN/TXN/DSP/ALB/GAPDH/LGALS3/DYNLL1/YWHAZ/UBC/HSPA8/MIF/EEF1A1/DSG1/ANXA2/CAPZA1/RPSA/GSTP1/SERPINB12/TUBB4B/PRDX6/NME2/SERPINB3/PKM/LCN1/FGG/HSPA2/LCN2/FGB/TAGLN2/KRT18/RAB7A/PSMB6/HRNR/PSMB4/S100A8/FGA/CAT/RPS15A/SLPI/CAPZB/EEF2/HBB/HSPA5/LYZ/AZGP1/RPL12/ATP5B/ANXA1/ALDOA/LMNA/CCT8/ACTN4/FLG2/GM2A/DSC1/HP/PSMB5/PSMA2/APOD/GSN/VCL/RPS2/ARG1/AGA/YOD1/HSP90AA1/LTF/CTSD/A2M/HNRNPK/HSPD1/CRABP2/VDAC3 +Muc GO:0051235 maintenance of location 8 8/181 S100A9/JUP/ALB/S100A8/HSPA5/GM2A/GSN/FLNB +Muc GO:0051641 cellular localization 33 33/181 HSPB1/PRDX1/JUP/SFN/TXN/ALB/DYNLL1/YWHAZ/UBC/HSPA8/ANXA2/CAPZA1/RPSA/TUBB4B/KRT18/RAB7A/RPS15A/CAPZB/HSPA5/RPL12/ATP5B/LMNA/CCT8/ACTN4/TRIM29/APOD/GSN/VCL/RPS2/YOD1/HSP90AA1/HSPD1/FLNB +Muc GO:0051674 localization of cell 21 21/181 KRT2/KRT16/DEFA1/DEFA1B/HSPB1/S100A9/JUP/PFN1/LGALS3/MIF/GSTP1/SERPINB3/S100A8/EPPK1/HSPA5/ATP5B/ANXA1/LMNA/ACTN4/APOD/VCL +Muc GO:0061842 microtubule organizing center localization 0 0/181 +Muc GO:1902579 multi-organism localization 2 2/181 UBC/RAB7A +Muc GO:0051707 response to other organism 23 23/181 DEFA1/DEFA1B/HSPB1/S100A9/GAPDH/ENO1/MIF/HIST1H2BK/GSTP1/LCN2/FGB/S100A8/FGA/RPS15A/SLPI/KLK5/LYZ/HP/PSMA2/KLK7/ARG1/LTF/EEF1G +Muc GO:0044366 feeding on or from other organism 0 0/181 +Muc GO:0044419 interspecies interaction between organisms 31 31/181 DEFA1/DEFA1B/S100A9/PFN1/ALB/GAPDH/DYNLL1/UBC/HSPA8/HIST1H2BK/ANXA2/RPSA/SERPINB3/KRT18/RAB7A/PSMB6/PSMB4/RPS15A/SLPI/LYZ/RPL12/EIF4A1/PSMB5/GSN/RPS2/ARG1/LTF/HNRNPK/HSPD1/PCBP1/IDE +Muc GO:0051703 intraspecies interaction between organisms 0 0/181 +Muc GO:0051816 acquisition of nutrients from other organism during symbiotic interaction 0 0/181 +Muc GO:0098630 aggregation of unicellular organisms 0 0/181 +Muc GO:0098740 multi organism cell adhesion 0 0/181 +Muc GO:0050789 regulation of biological process 127 127/181 KRT16/KRT17/CSTA/DEFA1/DEFA1B/CALML5/HSPB1/HIST1H2AH/PRDX1/ACTB/S100A11/S100A9/JUP/PKP1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/TXN/DSP/ALB/GAPDH/LGALS3/DYNLL1/YWHAZ/UBC/HSPA8/ENO1/IL36G/MIF/SERPINB5/EEF1A1/LDHA/ANXA2/CAPZA1/NCCRP1/RPSA/GSTP1/SERPINB12/TUBB4B/PRDX6/NME2/SERPINB3/LCN1/FGG/HSPA2/LCN2/FGB/KRT18/RAB7A/PSMB6/PSMB4/S100A8/FGA/EPPK1/CAT/PGK1/RPS15A/SLPI/CAPZB/EEF2/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/PRDX2/HBB/KLK5/HSPA5/AZGP1/TGM1/RPL12/ATP5B/TALDO1/ANXA1/ALDOA/LMNA/CCT8/ACTN4/GGCT/TRIM29/EIF4A1/HP/SERPINB2/PSMB5/DDX3Y/PSMA2/RNH1/APOD/GSN/KLK7/VCL/RPS2/ARG1/SERPINB13/YOD1/HSP90AA1/LTF/CDSN/SERPINA12/A2M/HNRNPK/HSPD1/TKT/FLNB/PCBP1/CRABP2/IDE/VDAC3 +Muc GO:0065008 regulation of biological quality 82 82/181 KRT16/HSPB1/PRDX1/ACTB/S100A9/JUP/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/SFN/TXN/DSP/ALB/GAPDH/DYNLL1/YWHAZ/UBC/HSPA8/MIF/DSG1/ANXA2/CAPZA1/GSTP1/PRDX6/NME2/LCN1/FGG/LCN2/FGB/RAB7A/PSMB6/HRNR/PSMB4/S100A8/FGA/CAPZB/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/PRDX2/HBB/HSPA5/LYZ/AZGP1/ATP5B/ANXA1/ALDOA/CCT8/FLG2/GM2A/SERPINB2/PSMB5/PSMA2/GSN/VCL/HSP90AA1/LTF/ALDH9A1/A2M/HSPD1/FLNB/CRABP2/IDE +Muc GO:0065009 regulation of molecular function 41 41/181 CSTA/HSPB1/S100A9/JUP/PFN1/SFN/TXN/GAPDH/DYNLL1/UBC/IL36G/MIF/SERPINB5/ANXA2/GSTP1/SERPINB12/SERPINB3/LCN1/HSPA2/PSMB6/PSMB4/S100A8/CAT/SLPI/HSPA5/ANXA1/ACTN4/GM2A/HP/SERPINB2/PSMB5/PSMA2/RNH1/GSN/RPS2/SERPINB13/HSP90AA1/LTF/SERPINA12/A2M/HSPD1 +Muc GO:1902727 negative regulation of growth factor dependent skeletal muscle satellite cell proliferation 0 0/181 +Muc GO:1902728 positive regulation of growth factor dependent skeletal muscle satellite cell proliferation 0 0/181 +Muc GO:0044085 cellular component biogenesis 69 69/181 KRT5/KRT14/ACTB/JUP/PKP1/PFN1/HIST1H4F/HIST1H4D/HIST1H4J/HIST1H4K/HIST1H4H/HIST1H4C/HIST1H4E/HIST1H4B/HIST1H4L/HIST1H4A/HIST2H4A/HIST1H4I/HIST2H4B/HIST4H4/DYNLL1/YWHAZ/UBC/HSPA8/MIF/HIST1H2BK/DSG1/ANXA2/CAPZA1/RPSA/TUBB4B/NME2/TGM3/PKM/FGG/HSPA2/LCN2/FGB/RAB7A/FGA/CAT/RPS15A/DMKN/CAPZB/HIST1H3B/HIST1H3F/HIST1H3A/HIST1H3D/HIST1H3C/HIST1H3E/HIST1H3I/HIST1H3G/HIST1H3J/HIST1H3H/POF1B/HBB/RPL12/ALDOA/CCT8/ACTN4/APOD/GSN/VCL/RPS2/ARG1/HSP90AA1/HSPD1/IDE/VDAC3 +Muc GO:0001502 cartilage condensation 0 0/181 +Muc GO:0009407 toxin catabolic process 0 0/181 +Muc GO:0010127 mycothiol-dependent detoxification 0 0/181 +Muc GO:0010312 detoxification of zinc ion 0 0/181 +Muc GO:0051410 detoxification of nitrogen compound 0 0/181 +Muc GO:0061687 detoxification of inorganic compound 0 0/181 +Muc GO:0071722 detoxification of arsenic-containing substance 0 0/181 +Muc GO:1990748 cellular detoxification 10 10/181 PRDX1/S100A9/TXN/ALB/GSTP1/PRDX6/CAT/PRDX2/HBB/HP +Muc GO:0016080 synaptic vesicle targeting 0 0/181 +Muc GO:0007269 neurotransmitter secretion 1 1/181 HSPA8 +Muc GO:0016079 synaptic vesicle exocytosis 0 0/181 +Muc GO:0016081 synaptic vesicle docking 0 0/181 +Muc GO:0016082 synaptic vesicle priming 0 0/181 +Muc GO:0031629 synaptic vesicle fusion to presynaptic active zone membrane 0 0/181 +Muc GO:0051583 dopamine uptake involved in synaptic transmission 0 0/181 +Muc GO:0099069 synaptic vesicle tethering involved in synaptic vesicle exocytosis 0 0/181 +Muc GO:0099502 calcium-dependent activation of synaptic vesicle fusion 0 0/181 +Muc GO:0099703 induction of synaptic vesicle exocytosis by positive regulation of presynaptic cytosolic calcium ion concentration 0 0/181
--- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/test-data/Muc.tsv Fri Jan 24 10:34:33 2020 -0500 @@ -0,0 +1,167 @@ +GeneID +3849 +3857 +3854 +3852 +3868 +3861 +3872 +1475 +3858 +1667;728358 +2171 +51806 +6704 +3315 +NA +85235 +5052 +60 +3860 +6282 +6280 +3728 +5317 +7167 +5216 +8361;8360;8363;8362;8365;8364;8367;8366;8368;8359;8370;8294;554313;121504 +2810 +7295 +1832 +374897 +213 +144501 +3850 +3963;653499 +2597 +3958 +29094 +8655 +7534 +7316 +338785 +3312 +2023 +374454 +NA +56300 +4282 +NA +5268 +1915 +85236 +196374 +3939 +1828 +302 +829 +342897 +3921 +2950 +89777 +10383 +9588 +810 +NA +4831;654364 +6317 +NA +7053 +25984 +5315 +3933 +2266 +3306 +NA +NA +3934 +6698 +2244 +NA +140807 +8407 +3875 +7879 +NA +5694 +388697 +448834 +5692 +6279 +2243 +83481 +100129271 +847 +5230 +6210 +6590 +93099 +832 +1938 +8358;8968;8350;8351;8352;8353;8354;8355;8356;8357 +7001 +79983 +284110 +3043 +25818 +3309 +NA +4069 +563 +7051 +6136 +506 +26227 +3892 +6888 +301 +226 +4000 +10694 +81 +388698 +2760 +79017 +23650 +1823 +1973 +3240 +3713 +5055 +5693 +8653 +5683 +6050 +217 +23581 +4014 +347 +2934 +5650 +7414 +6187 +383 +4190 +4191 +175 +5275 +55432 +3320 +4057 +4759 +191 +1509 +1041 +145264 +223 +2 +1937 +3190 +3329 +7086 +2317 +5093 +1382 +3416 +8581 +7419