From fbfdd907e20481b538650d76dc8752c497d2642b Mon Sep 17 00:00:00 2001 From: fsoubes Date: Fri, 18 May 2018 16:43:14 +0200 Subject: [PATCH] add start to go --- function/formating.R | 2 +- myip.sh | 0 server.R | 11 + server/heatmapshiny.R | 70 +- server/plotreact.R | 82 +- server/plotreact2.R | 59 +- temp/go.R | 347 +++ test.txt | 5597 +++++++++++++++++++++++++++++++++++++++++ 8 files changed, 6048 insertions(+), 120 deletions(-) mode change 100644 => 100755 myip.sh create mode 100644 temp/go.R create mode 100644 test.txt diff --git a/function/formating.R b/function/formating.R index a59ae45..cc34c62 100644 --- a/function/formating.R +++ b/function/formating.R @@ -261,7 +261,7 @@ heatmtoclust = function( hmp01_All, exprData, pval, myval= 5){ mygen = as.integer(row.names(final)) heatmclust = pval %>% - select (X,GeneName) %>% + dplyr::select (X,GeneName) %>% filter( X %in% mygen) %>% left_join(data.frame(X=mygen), . , by="X") %>% arrange(-row_number()) diff --git a/myip.sh b/myip.sh old mode 100644 new mode 100755 diff --git a/server.R b/server.R index 1e16667..eac0ec4 100644 --- a/server.R +++ b/server.R @@ -1,3 +1,7 @@ +############################### +######## Loading functions # +############################### + source("function/heatmtruncated.R") source("function/formating.R") source("function/PCA.R") @@ -6,9 +10,16 @@ source("function/decideTestTrix.R") source("function/vennplot.R") source("function/create_forked_task.R") source("function/cutheat.R") + +############################### +######## creating graph log # +############################### + + # options(shiny.reactlog=TRUE) # showReactLog(time = TRUE) + shinyServer(server <- function(input, output, session) { ############################### diff --git a/server/heatmapshiny.R b/server/heatmapshiny.R index 9a0b437..696ba50 100644 --- a/server/heatmapshiny.R +++ b/server/heatmapshiny.R @@ -4,7 +4,6 @@ - #' rowname is a reactive function which aim is to hide or show the rownames #' #' @param input$rowname a boolean radio button input @@ -38,18 +37,75 @@ colname <- reactive({ heatmapobj <- NULL # declare outside the observeEvent formatidus <- NULL +hmbis <- reactiveValues() +hmobj <- reactiveValues() + observe({ heatid <- input$matrixapp if (grepl("Heatmap", heatid)) { - formatidus <<- length(formated()) + formatidus <<- length(formated()) # doit trouver une autre valeur que formated pour donner la taille if (formatidus < 2000) source(file.path("server", "plotreact.R"), local = TRUE)$value # - else - source(file.path("server", "plotreact2.R"), local = TRUE)$value # + else + source(file.path("server", "plotreact2.R"), local = TRUE)$value # } + + + +# observe({ +# obj <- hmobj$hm +# print(obj) +# +# }) + + +output$save <- downloadHandler(filename <- function() { + paste0(basename(file_path_sans_ext("myfile")), + '_heatmap.', + input$form, + sep = '') +}, +content <- function(file) { + if (input$form == "emf") + + emf( + file, + width = 7, + height = 7, + pointsize = 12, + coordDPI = 300 + ) + else if (input$form == "png") + png( + file, + width = 900, + height = 1200, + units = "px", + pointsize = 12, + res = 100 + ) + else + eps(file, + width = 7, + height = 7) + + if (!is.null(formated())) + withProgress(message = 'Saving heatmap:', + value = 0, { + n <- NROW(formated()) + for (i in 1:n) { + incProgress(1 / n, detail = "Please wait...") + } + heatmapfinal(isplot = F) + }) + dev.off() + + }) + + output$downloadcut <- downloadHandler( filename = function() { paste(basename(file_path_sans_ext(input$filename)), @@ -62,9 +118,13 @@ observe({ } ) - output$clustering <- renderDataTable(heatmapfinal(isplot = T)) # Summary of the significant genes depending on the pvalue with FC set to (1.2,2,4,6,10) + output$clustering <- + renderDataTable(heatmapfinal(isplot = T)) # Summary of the significant genes depending on the pvalue with FC set to (1.2,2,4,6,10) }) + +obsC <- observe(quote({ print(formatidus) }), quoted = TRUE) + # cutedhm <- reactive({ # req(hm()) # cut02 = cut(hm()$rowDendrogram, h = input$cutheatm) diff --git a/server/plotreact.R b/server/plotreact.R index 0917c6e..b8c7bb3 100644 --- a/server/plotreact.R +++ b/server/plotreact.R @@ -29,10 +29,13 @@ #' +shinyjs::disable("heatm") + heatmapfinal <- function(isplot = T) { + plotHeatmaps( hmbis()[[1]], - formated(), + formated(), droplevels(new_group()$Grp), workingPath = wd_path, my_palette = colorRampPalette(c( @@ -52,6 +55,7 @@ heatmapfinal <- function(isplot = T) { gpcolr = hmbis()[[6]], distfunTRIX = hmbis()[[2]] ) + } #' hmbis is an event reactive function that pre-computed hierarchical clustering on microarray data @@ -72,12 +76,11 @@ heatmapfinal <- function(isplot = T) { hmbis <- reactive( { - #hmbis <- eventReactive(input$heatm, { - - isolate( # isolate in order to avoid that reactive values update the heatmap + + #isolate( # isolate in order to avoid that reactive values update the heatmap truncatedhat( data.matrix(new_data()), - formated(), + isolate(formated()), droplevels(new_group()$Grp), workingPath = wd_path, k = input$clusters, @@ -86,81 +89,36 @@ hmbis <- reactive( { Coldistfun = input$dist, meanGrp = input$meangrp ) - ) + + #) }) -#heatmapobj <<- hmbis() # a static variable +hm <- reactive({ + heatmapfinal(isplot = F) +}) output$distPlot <- renderPlot({ - isolate({ + #isolate({ if (!is.null(formated())) withProgress(message = 'Plotting heatmap:', # Add sliderbar when loading heatmap value = 0, { n <- NROW(formated()) #number of row in the formated dataframe - + if (n >2000) + return(isolate(heatmapfinal(isplot = F))) for (i in 1:n) { incProgress(1 / n, detail = "Please wait...") } - hmbis() + isolate(hmbis()) heatmapfinal(isplot = F) - }) - }) + #hmobj$hm <- (hm()) + + }) }, width = 900 , height = 1200, res = 100) -output$save <- downloadHandler(filename <- function() { - paste0(basename(file_path_sans_ext("myfile")), - '_heatmap.', - input$form, - sep = '') -}, -content <- function(file) { - if (input$form == "emf") - - emf( - file, - width = 7, - height = 7, - pointsize = 12, - coordDPI = 300 - ) - - else if (input$form == "png") - png( - file, - width = 900, - height = 1200, - units = "px", - pointsize = 12, - res = 100 - ) - else - eps(file, - width = 7, - height = 7) - - if (!is.null(formated())) - withProgress(message = 'Saving heatmap:', - value = 0, - { - n <- NROW(formated()) - - for (i in 1:n) { - incProgress(1 / n, detail = "Please wait...") - } - - heatmapfinal(isplot = F) - - }) - - dev.off() - - -}) - diff --git a/server/plotreact2.R b/server/plotreact2.R index bdba8ec..c40b70a 100644 --- a/server/plotreact2.R +++ b/server/plotreact2.R @@ -27,8 +27,11 @@ #' #' @export #' - - + + shinyjs::enable("heatm") + + + heatmapfinal <- function(isplot = T) { plotHeatmaps( heatmapobj[[1]], @@ -55,6 +58,7 @@ } + #' hmbis is an event reactive function that pre-computed hierarchical clustering on microarray data #' #' @param new_data a data frame with all the individuals selected @@ -109,53 +113,4 @@ }, width = 900 , height = 1200, res = 100) - output$save <- downloadHandler(filename <- function() { - paste0(basename(file_path_sans_ext("myfile")), - '_heatmap.', - input$form, - sep = '') - }, - content <- function(file) { - if (input$form == "emf") - - emf( - file, - width = 7, - height = 7, - pointsize = 12, - coordDPI = 300 - ) - - else if (input$form == "png") - png( - file, - width = 900, - height = 1200, - units = "px", - pointsize = 12, - res = 100 - ) - else - eps(file, - width = 7, - height = 7) - - if (!is.null(formated())) - withProgress(message = 'Saving heatmap:', - value = 0, - { - n <- NROW(formated()) - - for (i in 1:n) { - incProgress(1 / n, detail = "Please wait...") - } - - heatmapfinal(isplot = F) - - }) - - dev.off() - - - }) - + \ No newline at end of file diff --git a/temp/go.R b/temp/go.R new file mode 100644 index 0000000..569e001 --- /dev/null +++ b/temp/go.R @@ -0,0 +1,347 @@ +source("function/heatmtruncated.R") +source("function/cutheat.R") +source("function/formating.R") +#source("function/compat.R") + +# source("http://bioconductor.org/biocLite.R") +#biocLite("topGO") +source("http://bioconductor.org/biocLite.R") +biocLite() + +source("http://bioconductor.org/biocLite.R") +biocLite("goseq") +library(goseq) + +source("https://bioconductor.org/biocLite.R") +biocLite("DEGseq") + +source("https://bioconductor.org/biocLite.R") +biocLite("GO.db") +library(GO.db) + +source("https://bioconductor.org/biocLite.R") +biocLite("ALL") + +library(dplyr) +library(topGO) +#library(AnnotationDbi) +library(ALL) + +ource("https://bioconductor.org/biocLite.R") +biocLite("org.Mm.eg.db") +require("org.Mm.eg.db") + + + +library(dplyr) + +musmuscu <- read.csv2("data/TOXA_HEGU_MA0191_AllChip_WorkingSet.csv") +pval <- read.csv2("data/All_topTableAll.csv") +groupss <- read.csv2("data/TOXA_HEGU_MA0191_AllChip_pData.csv", sep= ";" , dec = ",",header= T) +adj = pval[,grep("X|^adj.P.Val_.LWT_MCD.LWT_CTRL...LKO_MCD.LKO_CTRL.|^adj.P.Val_LKO_CTRL.LWT_CTRL", names(pval), value=TRUE)] +#adj = pval[,grep("X|^adj.P.Val_.LWT_MCD.LWT_CTRL...LKO_MCD.LKO_CTRL.", names(pval), value=TRUE)] +require(Biobase) + +formating = function( adj, musmuscu,pval){ + + passingval = adj %>% + apply(2,FUN = function(x){return(x < 0.05)}) %>% + apply(1,sum) + + passingval = which( passingval > 0) + cat("Il y a",length(passingval),"gène significatifs") + + #row.names(musmuscu) = musmuscu$X + musmuscu <- data.matrix(musmuscu[,-1]) + + newlist = list(passingval, musmuscu ) + return(newlist) +} +row.names(musmuscu) = musmuscu$X +treated = formating(adj,musmuscu,pval= 0.05) + + + +hmbis = truncatedhat(treated[[2]],treated[[1]],groupss$Grp,workingPath=wd_path) +View(hmbis) +testos = c("green","red","orange","blue") +x11() +hm01 = plotHeatmaps(hmbis[[1]],treated[[1]],groupss$Grp,workingPath=wd_path,mypal = testos, + showcol = F, showrow = T,genename=pval, rowv = hmbis[[4]], ColvOrd = hmbis[[3]], + gpcol = hmbis[[5]], gpcolr = hmbis[[6]], distfunTRIX = hmbis[[2]] ) + + +affyLib <- paste(annotation(ALL), "db", sep = ".") +library(package = affyLib, character.only = TRUE) +View(data(ALL)) +print(affyLib) + + +filter(cluster == 1) +genlist <- hm01[! duplicated(hm01[ 2]), ] +genlist <- genlist %>% dplyr::select(cluster,GeneName) %>%`rownames<-`((genlist$GeneName)) + +#final = as.integer(genlist$cluster) +length(genlist$cluster) +final = as.double(matrix(0, length(genlist$cluster))) +names(final) = (row.names(genlist)) + +print(length(final)) +is(final) +View(final) +require("org.Mm.eg.db") + +all_genes <- rownames(exprs(as.character((genList)))) + +affyLib <- paste(annotation(final), "db", sep = ".") +library(package = "org.Mm.eg.db", character.only = TRUE) +print(affyLib) + +affyLib <- paste(annotation (ALL), "db", sep = ".") +library(package = affyLib, character.only = TRUE) +data(geneList) + +genlist$pvalue = 0.001 + +genons = genlist$pvalue +names(genons) <- as.character(genlist$GeneName) +View(genons) +typeof(genlist$GeneName) +typeof(genons) +class(genons) +View(genlist) +class(genlist$cluster) + +typeof(final) +class(final) + +View(final) +print(topDiffGenes) +sum(topDiffGenes(geneList)) +affyLib = "" +View(genons) +onts = c( "MF", "BP", "CC" ) +topDiffGenes +library("org.Mm.eg.db") +View(org.Mm.eg.db) +names(org.Mm.eg.db) +View(final) +data("geneList") +length(intersect(names(geneList), final)) +str(factor(final)) +final <- factor(final) +View(final) + +final = as.double(matrix(0.001, length(genlist$cluster))) +names(final) = (row.names(genlist)) +final[1] <- 0.02 +final +final <- factor(final) +final + +for(i in 1:3){ + +sampleGOdata <- new("topGOdata", + ontology = onts[i], + allGenes = (final), + nodeSize = 5,geneSel = topDiffGenes, + annot=annFUN.org, mapping="org.Mm.eg.db", ID = "ensembl" ) +} +str(final) +final +print(affyLib) +print(geneSelectionFun) +library(topGO) +go2genes <- annFUN.gene2GO(whichOnto = "MF", gene2GO = as.vector(genlist$GeneName)) + + + + +myInterestingGenes <- as.vector(genlist$GeneName) + + + + +go.obj <- new("topGOdata", ontology="MF", + allGenes = final + ,geneSel = topDiffGenes,annot=annFUN.gene2GO, + gene2GO="org.Mm.eg.db" +) + +# Mm.egGO2EG <- as.list(org.Mm.eg.db) +# get("GO:0045766", org.Mm.eg.db) +# +# View(Mm.egGO2EG) +# +# final = as.vector(as.double(matrix(0.001, length(genlist$cluster)))) +# names(final) = as.character(genlist[,2]) +# View(final) +# names(final) = (row.names(genlist)) +# final[1:10] +# +# sampleGOdata <- new("topGOdata", +# description = "Simple session", ontology = "MF", +# allGenes = final, geneSel = topDiffGenes, +# nodeSize = 10,annot=annFUN.org, mapping="org.Mm.eg.db") +# +# for(i in 1:3){ +# +# ## prepare data +# tgd <- new( "topGOdata", ontology=onts[i], allGenes = final, nodeSize=5, +# annot=annFUN.org, mapping= Mm.egGO2EG, ID = "ensembl" ) +# +# ## run tests +# resultTopGO.elim <- runTest(tgd, algorithm = "elim", statistic = "Fisher" ) +# resultTopGO.classic <- runTest(tgd, algorithm = "classic", statistic = "Fisher" ) +# +# ## look at results +# tab[[i]] <- GenTable( tgd, Fisher.elim = resultTopGO.elim, +# Fisher.classic = resultTopGO.classic, +# orderBy = "Fisher.classic" , topNodes = 200) +# +# } + +#ID = "ensembl" + + + +pwf <- final %>% nullp("mm9", "geneSymbol") %>% na.omit() +finalons <- + +test <- goseq(pwf, "mm9" , "geneSymbol", use_genes_without_cat = T) + + +Definition(test[[1]]) + +enriched.GO = test$category[p.adjust(test$over_represented_pvalue, method = "BH") < 0.05] +head(enriched.GO) +GOID(test[[1]]) + + +test$category[1:10] + +library(GO.db) +for(go in test$category){ + print(go) + print(Definition(test[[1]][[go]])) +} + +test <- as.list(GOTERM) +Term(test[[1]][1]) + + + +GOTERM[['GO:0005575']] +View(GOTERM) + +paste(clusterlist[[4]]$term, sep=",") + +cat(paste(shQuote(paste(clusterlist[[4]]$category,clusterlist[[4]]$term), type="sh"), collapse="\n"), file=con) + +View(clusterlist[[1]]) + +for (i in 1:length(clusterlist)){ + clusterlist[[i]] = arrange(clusterlist[[i]], desc(numInCat)) +} +View(clusterlist[[3]]) + +#pwf = nullp(final,"mm9", "geneSymbol") + +test <- final %>% nullp("mm9", "geneSymbol") %>% + na.omit() +View(test) +pwf[,1] + +View(pwf) +pwf_1 <<- pwf[which(pwf[,1] == 1),] +View(final) +finaled <- goseq(final,"mm9" , "geneSymbol",use_genes_without_cat =T) +View(finaled) +print(finaled) +#mettre une liste de species +# + +select() + +finaled$category + +Species <- reactive({ + if(input$Genome == "hg19"){ # human + require("org.Hs.eg.db") + } + else if (input$Genome == "mm9"){ # mouse + require("org.Mm.eg.db") + } + else if(input$Genome == "danRer6"){ #Zebra fish + require("org.Dr.eg.db") + } + else if(input$Genome == "galGal3"){ # chicken + require("org.Gg.eg.db") + } + else if(input$Genome == "equCab2"){ # horse + require("org.Gg.eg.db") + } + else if(input$Genome == "ce6"){ # cC elegans + require("org.Gg.eg.db") + } + else if(input$Genome == "rn4"){ # Rat + require("org.Gg.eg.db") + } + else if(input$Genome == "Pig"){ # Rat + require("org.Ss.e") + } + else if(input$Genome == "rn4"){ # Rat + require("org.Gg.eg.db") + } + else if(input$Genome == "rn4"){ # Rat + require("org.Gg.eg.db") + } +}) + + +clusterlist <- list() + +for (i in 1:NROW(unique(hm01$cluster))) { + + genlist <- hm01[!duplicated(hm01[2]),] + genlist <- + genlist %>% dplyr::select(cluster, GeneName) %>% filter(cluster == i) + final = as.double(matrix(0.001, length(genlist$cluster))) + names(final) = (genlist$GeneName) + pwf <- final %>% nullp("mm9", "geneSymbol") %>% na.omit() + finalons <- + goseq(pwf, "mm9" , "geneSymbol", use_genes_without_cat = T) + + clusterlist[[i]] = filter(finalons, numInCat >4 ) %>% + arrange(desc(numInCat)) + +} + + + +cat("Clustering", file="test.txt") +sink("test.txt") +sink() +con <- file("test.txt", "w") +for (i in 1:NROW(clusterlist)){ + if(!i==1) + cat("--------------------------------------\n",file=con) + cat(paste("cluster:", i), file=con) + if(!i==1) + cat("\n--------------------------------------\n",file=con) + cat("\n--------------------------------------\n",file=con) + if(!length(clusterlist[[1]][[i]]) == 0) { + for(go in 1:length(clusterlist[[i]][[1]])) { + cat(paste("GOID:",as.character(GOID(clusterlist[[i]][[1]][[go]]))),file=con) + cat("\n",file=con) + cat(paste("Term:",as.character(Term(clusterlist[[i]][[1]][[go]]))),file=con) + cat("\n",file=con) + cat(paste("Definition:",as.character(Definition(clusterlist[[i]][[1]][[go]]))),file=con) + cat("\n",file=con) + cat("--------------------------------------\n",file=con) + } + cat("\n",file=con) + } +} + +close(con) diff --git a/test.txt b/test.txt new file mode 100644 index 0000000..c99d27e --- /dev/null +++ b/test.txt @@ -0,0 +1,5597 @@ +cluster: 1 +-------------------------------------- +GOID: GO:0005575 +Term: cellular_component +Definition: The part of a cell or its extracellular environment in which a gene product is located. A gene product may be located in one or more parts of a cell and its location may be as specific as a particular macromolecular complex, that is, a stable, persistent association of macromolecules that function together. +-------------------------------------- +GOID: GO:0003674 +Term: molecular_function +Definition: Elemental activities, such as catalysis or binding, describing the actions of a gene product at the molecular level. A given gene product may exhibit one or more molecular functions. +-------------------------------------- +GOID: GO:0008150 +Term: biological_process +Definition: Any process specifically pertinent to the functioning of integrated living units: cells, tissues, organs, and organisms. A process is a collection of molecular events with a defined beginning and end. +-------------------------------------- +GOID: GO:0005623 +Term: cell +Definition: The basic structural and functional unit of all organisms. Includes the plasma membrane and any external encapsulating structures such as the cell wall and cell envelope. +-------------------------------------- +GOID: GO:0044464 +Term: cell part +Definition: Any constituent part of a cell, the basic structural and functional unit of all organisms. +-------------------------------------- +GOID: GO:0005622 +Term: intracellular +Definition: The living contents of a cell; the matter contained within (but not including) the plasma membrane, usually taken to exclude large vacuoles and masses of secretory or ingested material. In eukaryotes it includes the nucleus and cytoplasm. +-------------------------------------- +GOID: GO:0044424 +Term: intracellular part +Definition: Any constituent part of the living contents of a cell; the matter contained within (but not including) the plasma membrane, usually taken to exclude large vacuoles and masses of secretory or ingested material. In eukaryotes it includes the nucleus and cytoplasm. +-------------------------------------- +GOID: GO:0044699 +Term: single-organism process +Definition: A biological process that involves only one organism. +-------------------------------------- +GOID: GO:0043226 +Term: organelle +Definition: Organized structure of distinctive morphology and function. Includes the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton, and prokaryotic structures such as anammoxosomes and pirellulosomes. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0009987 +Term: cellular process +Definition: Any process that is carried out at the cellular level, but not necessarily restricted to a single cell. For example, cell communication occurs among more than one cell, but occurs at the cellular level. +-------------------------------------- +GOID: GO:0043227 +Term: membrane-bounded organelle +Definition: Organized structure of distinctive morphology and function, bounded by a single or double lipid bilayer membrane. Includes the nucleus, mitochondria, plastids, vacuoles, and vesicles. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0005737 +Term: cytoplasm +Definition: All of the contents of a cell excluding the plasma membrane and nucleus, but including other subcellular structures. +-------------------------------------- +GOID: GO:0043229 +Term: intracellular organelle +Definition: Organized structure of distinctive morphology and function, occurring within the cell. Includes the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0044763 +Term: single-organism cellular process +Definition: Any process that is carried out at the cellular level, occurring within a single organism. +-------------------------------------- +GOID: GO:0008152 +Term: metabolic process +Definition: The chemical reactions and pathways, including anabolism and catabolism, by which living organisms transform chemical substances. Metabolic processes typically transform small molecules, but also include macromolecular processes such as DNA repair and replication, and protein synthesis and degradation. +-------------------------------------- +GOID: GO:0043231 +Term: intracellular membrane-bounded organelle +Definition: Organized structure of distinctive morphology and function, bounded by a single or double lipid bilayer membrane and occurring within the cell. Includes the nucleus, mitochondria, plastids, vacuoles, and vesicles. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0005488 +Term: binding +Definition: The selective, non-covalent, often stoichiometric, interaction of a molecule with one or more specific sites on another molecule. +-------------------------------------- +GOID: GO:0071704 +Term: organic substance metabolic process +Definition: The chemical reactions and pathways involving an organic substance, any molecular entity containing carbon. +-------------------------------------- +GOID: GO:0003824 +Term: catalytic activity +Definition: Catalysis of a biochemical reaction at physiological temperatures. In biologically catalyzed reactions, the reactants are known as substrates, and the catalysts are naturally occurring macromolecular substances known as enzymes. Enzymes possess specific binding sites for substrates, and are usually composed wholly or largely of protein, but RNA that has catalytic activity (ribozyme) is often also regarded as enzymatic. +-------------------------------------- +GOID: GO:0044237 +Term: cellular metabolic process +Definition: The chemical reactions and pathways by which individual cells transform chemical substances. +-------------------------------------- +GOID: GO:0016020 +Term: membrane +Definition: A lipid bilayer along with all the proteins and protein complexes embedded in it an attached to it. +-------------------------------------- +GOID: GO:0044238 +Term: primary metabolic process +Definition: The chemical reactions and pathways involving those compounds which are formed as a part of the normal anabolic and catabolic processes. These processes take place in most, if not all, cells of the organism. +-------------------------------------- +GOID: GO:0044444 +Term: cytoplasmic part +Definition: Any constituent part of the cytoplasm, all of the contents of a cell excluding the plasma membrane and nucleus, but including other subcellular structures. +-------------------------------------- +GOID: GO:0065007 +Term: biological regulation +Definition: Any process that modulates a measurable attribute of any biological process, quality or function. +-------------------------------------- +GOID: GO:0005576 +Term: extracellular region +Definition: The space external to the outermost structure of a cell. For cells without external protective or external encapsulating structures this refers to space outside of the plasma membrane. This term covers the host cell environment outside an intracellular parasite. +-------------------------------------- +GOID: GO:0044710 +Term: single-organism metabolic process +Definition: A metabolic process - chemical reactions and pathways, including anabolism and catabolism, by which living organisms transform chemical substances - which involves a single organism. +-------------------------------------- +GOID: GO:0005515 +Term: protein binding +Definition: Interacting selectively and non-covalently with any protein or protein complex (a complex of two or more proteins that may include other nonprotein molecules). +-------------------------------------- +GOID: GO:0044421 +Term: extracellular region part +Definition: Any constituent part of the extracellular region, the space external to the outermost structure of a cell. For cells without external protective or external encapsulating structures this refers to space outside of the plasma membrane. This term covers constituent parts of the host cell environment outside an intracellular parasite. +-------------------------------------- +GOID: GO:0050789 +Term: regulation of biological process +Definition: Any process that modulates the frequency, rate or extent of a biological process. Biological processes are regulated by many means; examples include the control of gene expression, protein modification or interaction with a protein or substrate molecule. +-------------------------------------- +GOID: GO:0050896 +Term: response to stimulus +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. The process begins with detection of the stimulus and ends with a change in state or activity or the cell or organism. +-------------------------------------- +GOID: GO:0032501 +Term: multicellular organismal process +Definition: Any biological process, occurring at the level of a multicellular organism, pertinent to its function. +-------------------------------------- +GOID: GO:0044425 +Term: membrane part +Definition: Any constituent part of a membrane, a double layer of lipid molecules that encloses all cells, and, in eukaryotes, many organelles; may be a single or double lipid bilayer; also includes associated proteins. +-------------------------------------- +GOID: GO:0032502 +Term: developmental process +Definition: A biological process whose specific outcome is the progression of an integrated living unit: an anatomical structure (which may be a subcellular structure, cell, tissue, or organ), or organism over time from an initial condition to a later condition. +-------------------------------------- +GOID: GO:0044707 +Term: single-multicellular organism process +Definition: A biological process occurring within a single, multicellular organism. +-------------------------------------- +GOID: GO:0031982 +Term: vesicle +Definition: Any small, fluid-filled, spherical organelle enclosed by membrane. +-------------------------------------- +GOID: GO:0031988 +Term: membrane-bounded vesicle +Definition: Any small, fluid-filled, spherical organelle enclosed by a lipid bilayer. +-------------------------------------- +GOID: GO:0043230 +Term: extracellular organelle +Definition: Organized structure of distinctive morphology and function, occurring outside the cell. Includes, for example, extracellular membrane vesicles (EMVs) and the cellulosomes of anaerobic bacteria and fungi. +-------------------------------------- +GOID: GO:0044422 +Term: organelle part +Definition: Any constituent part of an organelle, an organized structure of distinctive morphology and function. Includes constituent parts of the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton, but excludes the plasma membrane. +-------------------------------------- +GOID: GO:0044446 +Term: intracellular organelle part +Definition: A constituent part of an intracellular organelle, an organized structure of distinctive morphology and function, occurring within the cell. Includes constituent parts of the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton but excludes the plasma membrane. +-------------------------------------- +GOID: GO:0051179 +Term: localization +Definition: Any process in which a cell, a substance, or a cellular entity, such as a protein complex or organelle, is transported, tethered to or otherwise maintained in a specific location. In the case of substances, localization may also be achieved via selective degradation. +-------------------------------------- +GOID: GO:0070062 +Term: extracellular exosome +Definition: A membrane-bounded vesicle that is released into the extracellular region by fusion of the limiting endosomal membrane of a multivesicular body with the plasma membrane. Extracellular exosomes, also simply called exosomes, have a diameter of about 40-100 nm. +-------------------------------------- +GOID: GO:1903561 +Term: extracellular vesicle +Definition: Any vesicle that is part of the extracellular region. +-------------------------------------- +GOID: GO:0005634 +Term: nucleus +Definition: A membrane-bounded organelle of eukaryotic cells in which chromosomes are housed and replicated. In most cells, the nucleus contains all of the cell's chromosomes except the organellar chromosomes, and is the site of RNA synthesis and processing. In some species, or in specialized cell types, RNA metabolism or DNA replication may be absent. +-------------------------------------- +GOID: GO:0044767 +Term: single-organism developmental process +Definition: A biological process whose specific outcome is the progression of an integrated living unit: an anatomical structure (which may be a subcellular structure, cell, tissue, or organ), or organism over time from an initial condition to a later condition, involving only one organism. +-------------------------------------- +GOID: GO:0048856 +Term: anatomical structure development +Definition: The biological process whose specific outcome is the progression of an anatomical structure from an initial condition to its mature state. This process begins with the formation of the structure and ends with the mature structure, whatever form that may be including its natural destruction. An anatomical structure is any biological entity that occupies space and is distinguished from its surroundings. Anatomical structures can be macroscopic such as a carpel, or microscopic such as an acrosome. +-------------------------------------- +GOID: GO:0050794 +Term: regulation of cellular process +Definition: Any process that modulates the frequency, rate or extent of a cellular process, any of those that are carried out at the cellular level, but are not necessarily restricted to a single cell. For example, cell communication occurs among more than one cell, but occurs at the cellular level. +-------------------------------------- +GOID: GO:0016021 +Term: integral component of membrane +Definition: The component of a membrane consisting of the gene products and protein complexes having at least some part of their peptide sequence embedded in the hydrophobic region of the membrane. +-------------------------------------- +GOID: GO:0031224 +Term: intrinsic component of membrane +Definition: The component of a membrane consisting of the gene products having some covalently attached portion, for example part of a peptide sequence or some other covalently attached group such as a GPI anchor, which spans or is embedded in one or both leaflets of the membrane. +-------------------------------------- +GOID: GO:0048518 +Term: positive regulation of biological process +Definition: Any process that activates or increases the frequency, rate or extent of a biological process. Biological processes are regulated by many means; examples include the control of gene expression, protein modification or interaction with a protein or substrate molecule. +-------------------------------------- +GOID: GO:0007275 +Term: multicellular organism development +Definition: The biological process whose specific outcome is the progression of a multicellular organism over time from an initial condition (e.g. a zygote or a young adult) to a later condition (e.g. a multicellular animal or an aged adult). +-------------------------------------- +GOID: GO:0048731 +Term: system development +Definition: The process whose specific outcome is the progression of an organismal system over time, from its formation to the mature structure. A system is a regularly interacting or interdependent group of organs or tissues that work together to carry out a given biological process. +-------------------------------------- +GOID: GO:0006807 +Term: nitrogen compound metabolic process +Definition: The chemical reactions and pathways involving organic or inorganic compounds that contain nitrogen, including (but not limited to) nitrogen fixation, nitrification, denitrification, assimilatory/dissimilatory nitrate reduction and the interconversion of nitrogenous organic matter and ammonium. +-------------------------------------- +GOID: GO:0012505 +Term: endomembrane system +Definition: A collection of membranous structures involved in transport within the cell. The main components of the endomembrane system are endoplasmic reticulum, Golgi bodies, vesicles, cell membrane and nuclear envelope. Members of the endomembrane system pass materials through each other or though the use of vesicles. +-------------------------------------- +GOID: GO:0034641 +Term: cellular nitrogen compound metabolic process +Definition: The chemical reactions and pathways involving various organic and inorganic nitrogenous compounds, as carried out by individual cells. +-------------------------------------- +GOID: GO:1901360 +Term: organic cyclic compound metabolic process +Definition: The chemical reactions and pathways involving organic cyclic compound. +-------------------------------------- +GOID: GO:0005783 +Term: endoplasmic reticulum +Definition: The irregular network of unit membranes, visible only by electron microscopy, that occurs in the cytoplasm of many eukaryotic cells. The membranes form a complex meshwork of tubular channels, which are often expanded into slitlike cavities called cisternae. The ER takes two forms, rough (or granular), with ribosomes adhering to the outer surface, and smooth (with no ribosomes attached). +-------------------------------------- +GOID: GO:0009058 +Term: biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of substances; typically the energy-requiring part of metabolism in which simpler substances are transformed into more complex ones. +-------------------------------------- +GOID: GO:0016043 +Term: cellular component organization +Definition: A process that results in the assembly, arrangement of constituent parts, or disassembly of a cellular component. +-------------------------------------- +GOID: GO:0043167 +Term: ion binding +Definition: Interacting selectively and non-covalently with ions, charged atoms or groups of atoms. +-------------------------------------- +GOID: GO:0071840 +Term: cellular component organization or biogenesis +Definition: A process that results in the biosynthesis of constituent macromolecules, assembly, arrangement of constituent parts, or disassembly of a cellular component. +-------------------------------------- +GOID: GO:1901576 +Term: organic substance biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of an organic substance, any molecular entity containing carbon. +-------------------------------------- +GOID: GO:0005886 +Term: plasma membrane +Definition: The membrane surrounding a cell that separates the cell from its external environment. It consists of a phospholipid bilayer and associated proteins. +-------------------------------------- +GOID: GO:0006810 +Term: transport +Definition: The directed movement of substances (such as macromolecules, small molecules, ions) or cellular components (such as complexes and organelles) into, out of or within a cell, or between cells, or within a multicellular organism by means of some agent such as a transporter, pore or motor protein. +-------------------------------------- +GOID: GO:0043169 +Term: cation binding +Definition: Interacting selectively and non-covalently with cations, charged atoms or groups of atoms with a net positive charge. +-------------------------------------- +GOID: GO:0043170 +Term: macromolecule metabolic process +Definition: The chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0044249 +Term: cellular biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of substances, carried out by individual cells. +-------------------------------------- +GOID: GO:0044260 +Term: cellular macromolecule metabolic process +Definition: The chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass, as carried out by individual cells. +-------------------------------------- +GOID: GO:0044281 +Term: small molecule metabolic process +Definition: The chemical reactions and pathways involving small molecules, any low molecular weight, monomeric, non-encoded molecule. +-------------------------------------- +GOID: GO:0048522 +Term: positive regulation of cellular process +Definition: Any process that activates or increases the frequency, rate or extent of a cellular process, any of those that are carried out at the cellular level, but are not necessarily restricted to a single cell. For example, cell communication occurs among more than one cell, but occurs at the cellular level. +-------------------------------------- +GOID: GO:0051234 +Term: establishment of localization +Definition: Any process that localizes a substance or cellular component. This may occur via movement, tethering or selective degradation. +-------------------------------------- +GOID: GO:0051716 +Term: cellular response to stimulus +Definition: Any process that results in a change in state or activity of a cell (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. The process begins with detection of the stimulus by a cell and ends with a change in state or activity or the cell. +-------------------------------------- +GOID: GO:0065008 +Term: regulation of biological quality +Definition: Any process that modulates a qualitative or quantitative trait of a biological quality. A biological quality is a measurable attribute of an organism or part of an organism, such as size, mass, shape, color, etc. +-------------------------------------- +GOID: GO:0071944 +Term: cell periphery +Definition: The part of a cell encompassing the cell cortex, the plasma membrane, and any external encapsulating structures. +-------------------------------------- +GOID: GO:0006725 +Term: cellular aromatic compound metabolic process +Definition: The chemical reactions and pathways involving aromatic compounds, any organic compound characterized by one or more planar rings, each of which contains conjugated double bonds and delocalized pi electrons, as carried out by individual cells. +-------------------------------------- +GOID: GO:0032991 +Term: macromolecular complex +Definition: A stable assembly of two or more macromolecules, i.e. proteins, nucleic acids, carbohydrates or lipids, in which the constituent parts function together. +-------------------------------------- +GOID: GO:0042221 +Term: response to chemical +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a chemical stimulus. +-------------------------------------- +GOID: GO:0046483 +Term: heterocycle metabolic process +Definition: The chemical reactions and pathways involving heterocyclic compounds, those with a cyclic molecular structure and at least two different atoms in the ring (or rings). +-------------------------------------- +GOID: GO:0046872 +Term: metal ion binding +Definition: Interacting selectively and non-covalently with any metal ion. +-------------------------------------- +GOID: GO:0048519 +Term: negative regulation of biological process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of a biological process. Biological processes are regulated by many means; examples include the control of gene expression, protein modification or interaction with a protein or substrate molecule. +-------------------------------------- +GOID: GO:0097159 +Term: organic cyclic compound binding +Definition: Interacting selectively and non-covalently with an organic cyclic compound, any molecular entity that contains carbon arranged in a cyclic molecular structure. +-------------------------------------- +GOID: GO:1901363 +Term: heterocyclic compound binding +Definition: Interacting selectively and non-covalently with heterocyclic compound. +-------------------------------------- +GOID: GO:0006139 +Term: nucleobase-containing compound metabolic process +Definition: Any cellular metabolic process involving nucleobases, nucleosides, nucleotides and nucleic acids. +-------------------------------------- +GOID: GO:0006793 +Term: phosphorus metabolic process +Definition: The chemical reactions and pathways involving the nonmetallic element phosphorus or compounds that contain phosphorus, usually in the form of a phosphate group (PO4). +-------------------------------------- +GOID: GO:0006796 +Term: phosphate-containing compound metabolic process +Definition: The chemical reactions and pathways involving the phosphate group, the anion or salt of any phosphoric acid. +-------------------------------------- +GOID: GO:0007154 +Term: cell communication +Definition: Any process that mediates interactions between a cell and its surroundings. Encompasses interactions such as signaling or attachment between one cell and another cell, between a cell and an extracellular matrix, or between a cell and any other aspect of its environment. +-------------------------------------- +GOID: GO:0016740 +Term: transferase activity +Definition: Catalysis of the transfer of a group, e.g. a methyl group, glycosyl group, acyl group, phosphorus-containing, or other groups, from one compound (generally regarded as the donor) to another compound (generally regarded as the acceptor). Transferase is the systematic name for any enzyme of EC class 2. +-------------------------------------- +GOID: GO:0023052 +Term: signaling +Definition: The entirety of a process in which information is transmitted within a biological system. This process begins with an active signal and ends when a cellular response has been triggered. +-------------------------------------- +GOID: GO:0044700 +Term: single organism signaling +Definition: A signaling process occurring within a single organism. +-------------------------------------- +GOID: GO:0007165 +Term: signal transduction +Definition: The cellular process in which a signal is conveyed to trigger a change in the activity or state of a cell. Signal transduction begins with reception of a signal (e.g. a ligand binding to a receptor or receptor activation by a stimulus such as light), or for signal transduction in the absence of ligand, signal-withdrawal or the activity of a constitutively active receptor. Signal transduction ends with regulation of a downstream cellular process, e.g. regulation of transcription or regulation of a metabolic process. Signal transduction covers signaling from receptors located on the surface of the cell and signaling via molecules located within the cell. For signaling between cells, signal transduction is restricted to events at and within the receiving cell. +-------------------------------------- +GOID: GO:0007399 +Term: nervous system development +Definition: The process whose specific outcome is the progression of nervous tissue over time, from its formation to its mature state. +-------------------------------------- +GOID: GO:0010033 +Term: response to organic substance +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an organic substance stimulus. +-------------------------------------- +GOID: GO:0019222 +Term: regulation of metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways within a cell or an organism. +-------------------------------------- +GOID: GO:0032879 +Term: regulation of localization +Definition: Any process that modulates the frequency, rate or extent of any process in which a cell, a substance, or a cellular entity is transported to, or maintained in, a specific location. +-------------------------------------- +GOID: GO:0033036 +Term: macromolecule localization +Definition: Any process in which a macromolecule is transported to, or maintained in, a specific location. +-------------------------------------- +GOID: GO:0048523 +Term: negative regulation of cellular process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of a cellular process, any of those that are carried out at the cellular level, but are not necessarily restricted to a single cell. For example, cell communication occurs among more than one cell, but occurs at the cellular level. +-------------------------------------- +GOID: GO:0048869 +Term: cellular developmental process +Definition: A biological process whose specific outcome is the progression of a cell over time from an initial condition to a later condition. +-------------------------------------- +GOID: GO:0080090 +Term: regulation of primary metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways within a cell or an organism involving those compounds formed as a part of the normal anabolic and catabolic processes. These processes take place in most, if not all, cells of the organism. +-------------------------------------- +GOID: GO:0006629 +Term: lipid metabolic process +Definition: The chemical reactions and pathways involving lipids, compounds soluble in an organic solvent but not, or sparingly, in an aqueous solvent. Includes fatty acids; neutral fats, other fatty-acid esters, and soaps; long-chain (fatty) alcohols and waxes; sphingoids and other long-chain bases; glycolipids, phospholipids and sphingolipids; and carotenes, polyprenols, sterols, terpenes and other isoprenoids. +-------------------------------------- +GOID: GO:0009056 +Term: catabolic process +Definition: The chemical reactions and pathways resulting in the breakdown of substances, including the breakdown of carbon compounds with the liberation of energy for use by the cell or organism. +-------------------------------------- +GOID: GO:0019538 +Term: protein metabolic process +Definition: The chemical reactions and pathways involving a specific protein, rather than of proteins in general. Includes protein modification. +-------------------------------------- +GOID: GO:0030154 +Term: cell differentiation +Definition: The process in which relatively unspecialized cells, e.g. embryonic or regenerative cells, acquire specialized structural and/or functional features that characterize the cells, tissues, or organs of the mature organism or some other relatively stable phase of the organism's life history. Differentiation includes the processes involved in commitment of a cell to a specific fate and its subsequent development to the mature state. +-------------------------------------- +GOID: GO:0031323 +Term: regulation of cellular metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways by which individual cells transform chemical substances. +-------------------------------------- +GOID: GO:0044765 +Term: single-organism transport +Definition: The directed movement of substances (such as macromolecules, small molecules, ions) into, out of or within a cell, or between cells, or within a multicellular organism by means of some agent such as a transporter or pore, involving a single organism. +-------------------------------------- +GOID: GO:0050793 +Term: regulation of developmental process +Definition: Any process that modulates the frequency, rate or extent of development, the biological process whose specific outcome is the progression of a multicellular organism over time from an initial condition (e.g. a zygote, or a young adult) to a later condition (e.g. a multicellular animal or an aged adult). +-------------------------------------- +GOID: GO:0051239 +Term: regulation of multicellular organismal process +Definition: Any process that modulates the frequency, rate or extent of a multicellular organismal process, the processes pertinent to the function of a multicellular organism above the cellular level; includes the integrated processes of tissues and organs. +-------------------------------------- +GOID: GO:0071702 +Term: organic substance transport +Definition: The directed movement of organic substances into, out of or within a cell, or between cells, or within a multicellular organism by means of some agent such as a transporter or pore. An organic substance is a molecular entity that contains carbon. +-------------------------------------- +GOID: GO:1902578 +Term: single-organism localization +Definition: A localization which involves only one organism. +-------------------------------------- +GOID: GO:0006082 +Term: organic acid metabolic process +Definition: The chemical reactions and pathways involving organic acids, any acidic compound containing carbon in covalent linkage. +-------------------------------------- +GOID: GO:0006950 +Term: response to stress +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a disturbance in organismal or cellular homeostasis, usually, but not necessarily, exogenous (e.g. temperature, humidity, ionizing radiation). +-------------------------------------- +GOID: GO:0043228 +Term: non-membrane-bounded organelle +Definition: Organized structure of distinctive morphology and function, not bounded by a lipid bilayer membrane. Includes ribosomes, the cytoskeleton and chromosomes. +-------------------------------------- +GOID: GO:0043232 +Term: intracellular non-membrane-bounded organelle +Definition: Organized structure of distinctive morphology and function, not bounded by a lipid bilayer membrane and occurring within the cell. Includes ribosomes, the cytoskeleton and chromosomes. +-------------------------------------- +GOID: GO:0043234 +Term: protein complex +Definition: A stable macromolecular complex composed (only) of two or more polypeptide subunits along with any covalently attached molecules (such as lipid anchors or oligosaccharide) or non-protein prosthetic groups (such as nucleotides or metal ions). Prosthetic group in this context refers to a tightly bound cofactor. The component polypeptide subunits may be identical. +-------------------------------------- +GOID: GO:0044255 +Term: cellular lipid metabolic process +Definition: The chemical reactions and pathways involving lipids, as carried out by individual cells. +-------------------------------------- +GOID: GO:0044267 +Term: cellular protein metabolic process +Definition: The chemical reactions and pathways involving a specific protein, rather than of proteins in general, occurring at the level of an individual cell. Includes cellular protein modification. +-------------------------------------- +GOID: GO:0060255 +Term: regulation of macromolecule metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:1901564 +Term: organonitrogen compound metabolic process +Definition: The chemical reactions and pathways involving organonitrogen compound. +-------------------------------------- +GOID: GO:1901575 +Term: organic substance catabolic process +Definition: The chemical reactions and pathways resulting in the breakdown of an organic substance, any molecular entity containing carbon. +-------------------------------------- +GOID: GO:1901700 +Term: response to oxygen-containing compound +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an oxygen-containing compound stimulus. +-------------------------------------- +GOID: GO:0009893 +Term: positive regulation of metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways within a cell or an organism. +-------------------------------------- +GOID: GO:0010646 +Term: regulation of cell communication +Definition: Any process that modulates the frequency, rate or extent of cell communication. Cell communication is the process that mediates interactions between a cell and its surroundings. Encompasses interactions such as signaling or attachment between one cell and another cell, between a cell and an extracellular matrix, or between a cell and any other aspect of its environment. +-------------------------------------- +GOID: GO:0016491 +Term: oxidoreductase activity +Definition: Catalysis of an oxidation-reduction (redox) reaction, a reversible chemical reaction in which the oxidation state of an atom or atoms within a molecule is altered. One substrate acts as a hydrogen or electron donor and becomes oxidized, while the other acts as hydrogen or electron acceptor and becomes reduced. +-------------------------------------- +GOID: GO:0016787 +Term: hydrolase activity +Definition: Catalysis of the hydrolysis of various bonds, e.g. C-O, C-N, C-C, phosphoric anhydride bonds, etc. Hydrolase is the systematic name for any enzyme of EC class 3. +-------------------------------------- +GOID: GO:0019637 +Term: organophosphate metabolic process +Definition: The chemical reactions and pathways involving organophosphates, any phosphate-containing organic compound. +-------------------------------------- +GOID: GO:0019752 +Term: carboxylic acid metabolic process +Definition: The chemical reactions and pathways involving carboxylic acids, any organic acid containing one or more carboxyl (COOH) groups or anions (COO-). +-------------------------------------- +GOID: GO:0023051 +Term: regulation of signaling +Definition: Any process that modulates the frequency, rate or extent of a signaling process. +-------------------------------------- +GOID: GO:0032787 +Term: monocarboxylic acid metabolic process +Definition: The chemical reactions and pathways involving monocarboxylic acids, any organic acid containing one carboxyl (COOH) group or anion (COO-). +-------------------------------------- +GOID: GO:0043436 +Term: oxoacid metabolic process +Definition: The chemical reactions and pathways involving any oxoacid; an oxoacid is a compound which contains oxygen, at least one other element, and at least one hydrogen bound to oxygen, and which produces a conjugate base by loss of positive hydrogen ion(s) (hydrons). +-------------------------------------- +GOID: GO:0044711 +Term: single-organism biosynthetic process +Definition: A biosynthetic process - chemical reactions and pathways resulting in the formation of substances - involving a single organism. +-------------------------------------- +GOID: GO:0048513 +Term: animal organ development +Definition: Development of a tissue or tissues that work together to perform a specific function or functions. Development pertains to the process whose specific outcome is the progression of a structure over time, from its formation to the mature structure. Organs are commonly observed as visibly distinct structures, but may also exist as loosely associated clusters of cells that work together to perform a specific function or functions. +-------------------------------------- +GOID: GO:0048583 +Term: regulation of response to stimulus +Definition: Any process that modulates the frequency, rate or extent of a response to a stimulus. Response to stimulus is a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. +-------------------------------------- +GOID: GO:0051049 +Term: regulation of transport +Definition: Any process that modulates the frequency, rate or extent of the directed movement of substances (such as macromolecules, small molecules, ions) into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:0070887 +Term: cellular response to chemical stimulus +Definition: Any process that results in a change in state or activity of a cell (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a chemical stimulus. +-------------------------------------- +GOID: GO:0005739 +Term: mitochondrion +Definition: A semiautonomous, self replicating organelle that occurs in varying numbers, shapes, and sizes in the cytoplasm of virtually all eukaryotic cells. It is notably the site of tissue respiration. +-------------------------------------- +GOID: GO:0007155 +Term: cell adhesion +Definition: The attachment of a cell, either to another cell or to an underlying substrate such as the extracellular matrix, via cell adhesion molecules. +-------------------------------------- +GOID: GO:0008104 +Term: protein localization +Definition: Any process in which a protein is transported to, or maintained in, a specific location. +-------------------------------------- +GOID: GO:0008219 +Term: cell death +Definition: Any biological process that results in permanent cessation of all vital functions of a cell. A cell should be considered dead when any one of the following molecular or morphological criteria is met: (1) the cell has lost the integrity of its plasma membrane; (2) the cell, including its nucleus, has undergone complete fragmentation into discrete bodies (frequently referred to as apoptotic bodies). The cell corpse (or its fragments) may be engulfed by an adjacent cell in vivo, but engulfment of whole cells should not be considered a strict criteria to define cell death as, under some circumstances, live engulfed cells can be released from phagosomes (see PMID:18045538). +-------------------------------------- +GOID: GO:0009966 +Term: regulation of signal transduction +Definition: Any process that modulates the frequency, rate or extent of signal transduction. +-------------------------------------- +GOID: GO:0010467 +Term: gene expression +Definition: The process in which a gene's sequence is converted into a mature gene product or products (proteins or RNA). This includes the production of an RNA transcript as well as any processing to produce a mature RNA product or an mRNA (for protein-coding genes) and the translation of that mRNA into protein. Protein maturation is included when required to form an active form of a product from an inactive precursor form. +-------------------------------------- +GOID: GO:0015031 +Term: protein transport +Definition: The directed movement of proteins into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:0016310 +Term: phosphorylation +Definition: The process of introducing a phosphate group into a molecule, usually with the formation of a phosphoric ester, a phosphoric anhydride or a phosphoric amide. +-------------------------------------- +GOID: GO:0022610 +Term: biological adhesion +Definition: The attachment of a cell or organism to a substrate, another cell, or other organism. Biological adhesion includes intracellular attachment between membrane regions. +-------------------------------------- +GOID: GO:0031325 +Term: positive regulation of cellular metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways by which individual cells transform chemical substances. +-------------------------------------- +GOID: GO:0032880 +Term: regulation of protein localization +Definition: Any process that modulates the frequency, rate or extent of any process in which a protein is transported to, or maintained in, a specific location. +-------------------------------------- +GOID: GO:0035556 +Term: intracellular signal transduction +Definition: The process in which a signal is passed on to downstream components within the cell, which become activated themselves to further propagate the signal and finally trigger a change in the function or state of the cell. +-------------------------------------- +GOID: GO:0043412 +Term: macromolecule modification +Definition: The covalent alteration of one or more monomeric units in a polypeptide, polynucleotide, polysaccharide, or other biological macromolecule, resulting in a change in its properties. +-------------------------------------- +GOID: GO:0044271 +Term: cellular nitrogen compound biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of organic and inorganic nitrogenous compounds. +-------------------------------------- +GOID: GO:0045184 +Term: establishment of protein localization +Definition: The directed movement of a protein to a specific location. +-------------------------------------- +GOID: GO:0048468 +Term: cell development +Definition: The process whose specific outcome is the progression of the cell over time, from its formation to the mature structure. Cell development does not include the steps involved in committing a cell to a specific fate. +-------------------------------------- +GOID: GO:0051128 +Term: regulation of cellular component organization +Definition: Any process that modulates the frequency, rate or extent of a process involved in the formation, arrangement of constituent parts, or disassembly of cell structures, including the plasma membrane and any external encapsulating structures such as the cell wall and cell envelope. +-------------------------------------- +GOID: GO:0051246 +Term: regulation of protein metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving a protein. +-------------------------------------- +GOID: GO:0071310 +Term: cellular response to organic substance +Definition: Any process that results in a change in state or activity of a cell (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an organic substance stimulus. +-------------------------------------- +GOID: GO:1901135 +Term: carbohydrate derivative metabolic process +Definition: The chemical reactions and pathways involving carbohydrate derivative. +-------------------------------------- +GOID: GO:2000026 +Term: regulation of multicellular organismal development +Definition: Any process that modulates the frequency, rate or extent of multicellular organismal development. +-------------------------------------- +GOID: GO:0003676 +Term: nucleic acid binding +Definition: Interacting selectively and non-covalently with any nucleic acid. +-------------------------------------- +GOID: GO:0005829 +Term: cytosol +Definition: The part of the cytoplasm that does not contain organelles but which does contain other particulate matter, such as protein complexes. +-------------------------------------- +GOID: GO:0006464 +Term: cellular protein modification process +Definition: The covalent alteration of one or more amino acids occurring in proteins, peptides and nascent polypeptides (co-translational, post-translational modifications) occurring at the level of an individual cell. Includes the modification of charged tRNAs that are destined to occur in a protein (pre-translation modification). +-------------------------------------- +GOID: GO:0006631 +Term: fatty acid metabolic process +Definition: The chemical reactions and pathways involving fatty acids, aliphatic monocarboxylic acids liberated from naturally occurring fats and oils by hydrolysis. +-------------------------------------- +GOID: GO:0006915 +Term: apoptotic process +Definition: A programmed cell death process which begins when a cell receives an internal (e.g. DNA damage) or external signal (e.g. an extracellular death ligand), and proceeds through a series of biochemical events (signaling pathway phase) which trigger an execution phase. The execution phase is the last step of an apoptotic process, and is typically characterized by rounding-up of the cell, retraction of pseudopodes, reduction of cellular volume (pyknosis), chromatin condensation, nuclear fragmentation (karyorrhexis), plasma membrane blebbing and fragmentation of the cell into apoptotic bodies. When the execution phase is completed, the cell has died. +-------------------------------------- +GOID: GO:0007166 +Term: cell surface receptor signaling pathway +Definition: A series of molecular signals initiated by activation of a receptor on the surface of a cell. The pathway begins with binding of an extracellular ligand to a cell surface receptor, or for receptors that signal in the absence of a ligand, by ligand-withdrawal or the activity of a constitutively active receptor. The pathway ends with regulation of a downstream cellular process, e.g. transcription. +-------------------------------------- +GOID: GO:0008283 +Term: cell proliferation +Definition: The multiplication or reproduction of cells, resulting in the expansion of a cell population. +-------------------------------------- +GOID: GO:0009059 +Term: macromolecule biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of a macromolecule, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0009653 +Term: anatomical structure morphogenesis +Definition: The process in which anatomical structures are generated and organized. Morphogenesis pertains to the creation of form. +-------------------------------------- +GOID: GO:0009888 +Term: tissue development +Definition: The process whose specific outcome is the progression of a tissue over time, from its formation to the mature structure. +-------------------------------------- +GOID: GO:0009889 +Term: regulation of biosynthetic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways resulting in the formation of substances. +-------------------------------------- +GOID: GO:0010604 +Term: positive regulation of macromolecule metabolic process +Definition: Any process that increases the frequency, rate or extent of the chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0010941 +Term: regulation of cell death +Definition: Any process that modulates the rate or frequency of cell death. Cell death is the specific activation or halting of processes within a cell so that its vital functions markedly cease, rather than simply deteriorating gradually over time, which culminates in cell death. +-------------------------------------- +GOID: GO:0012501 +Term: programmed cell death +Definition: A process which begins when a cell receives an internal or external signal and activates a series of biochemical events (signaling pathway). The process ends with the death of the cell. +-------------------------------------- +GOID: GO:0019438 +Term: aromatic compound biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of aromatic compounds, any substance containing an aromatic carbon ring. +-------------------------------------- +GOID: GO:0022008 +Term: neurogenesis +Definition: Generation of cells within the nervous system. +-------------------------------------- +GOID: GO:0022607 +Term: cellular component assembly +Definition: The aggregation, arrangement and bonding together of a cellular component. +-------------------------------------- +GOID: GO:0030182 +Term: neuron differentiation +Definition: The process in which a relatively unspecialized cell acquires specialized features of a neuron. +-------------------------------------- +GOID: GO:0031090 +Term: organelle membrane +Definition: A membrane that is one of the two lipid bilayers of an organelle envelope or the outermost membrane of single membrane bound organelle. +-------------------------------------- +GOID: GO:0031974 +Term: membrane-enclosed lumen +Definition: The enclosed volume within a sealed membrane or between two sealed membranes. Encompasses the volume enclosed by the membranes of a particular organelle, e.g. endoplasmic reticulum lumen, or the space between the two lipid bilayers of a double membrane surrounding an organelle, e.g. nuclear envelope lumen. +-------------------------------------- +GOID: GO:0032268 +Term: regulation of cellular protein metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving a protein, occurring at the level of an individual cell. +-------------------------------------- +GOID: GO:0034645 +Term: cellular macromolecule biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of a macromolecule, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass, carried out by individual cells. +-------------------------------------- +GOID: GO:0036211 +Term: protein modification process +Definition: The covalent alteration of one or more amino acids occurring in proteins, peptides and nascent polypeptides (co-translational, post-translational modifications). Includes the modification of charged tRNAs that are destined to occur in a protein (pre-translation modification). +-------------------------------------- +GOID: GO:0042802 +Term: identical protein binding +Definition: Interacting selectively and non-covalently with an identical protein or proteins. +-------------------------------------- +GOID: GO:0043233 +Term: organelle lumen +Definition: The internal volume enclosed by the membranes of a particular organelle; includes the volume enclosed by a single organelle membrane, e.g. endoplasmic reticulum lumen, or the volume enclosed by the innermost of the two lipid bilayers of an organelle envelope, e.g. nuclear lumen. +-------------------------------------- +GOID: GO:0044085 +Term: cellular component biogenesis +Definition: A process that results in the biosynthesis of constituent macromolecules, assembly, and arrangement of constituent parts of a cellular component. Includes biosynthesis of constituent macromolecules, and those macromolecular modifications that are involved in synthesis or assembly of the cellular component. +-------------------------------------- +GOID: GO:0044248 +Term: cellular catabolic process +Definition: The chemical reactions and pathways resulting in the breakdown of substances, carried out by individual cells. +-------------------------------------- +GOID: GO:0044428 +Term: nuclear part +Definition: Any constituent part of the nucleus, a membrane-bounded organelle of eukaryotic cells in which chromosomes are housed and replicated. +-------------------------------------- +GOID: GO:0044459 +Term: plasma membrane part +Definition: Any constituent part of the plasma membrane, the membrane surrounding a cell that separates the cell from its external environment. It consists of a phospholipid bilayer and associated proteins. +-------------------------------------- +GOID: GO:0044712 +Term: single-organism catabolic process +Definition: A catabolic process - chemical reactions and pathways resulting in the breakdown of substances - which involves a single organism. +-------------------------------------- +GOID: GO:0045595 +Term: regulation of cell differentiation +Definition: Any process that modulates the frequency, rate or extent of cell differentiation, the process in which relatively unspecialized cells acquire specialized structural and functional features. +-------------------------------------- +GOID: GO:0048699 +Term: generation of neurons +Definition: The process in which nerve cells are generated. This includes the production of neuroblasts and their differentiation into neurons. +-------------------------------------- +GOID: GO:0055114 +Term: oxidation-reduction process +Definition: A metabolic process that results in the removal or addition of one or more electrons to or from a substance, with or without the concomitant removal or addition of a proton or protons. +-------------------------------------- +GOID: GO:0070013 +Term: intracellular organelle lumen +Definition: An organelle lumen that is part of an intracellular organelle. +-------------------------------------- +GOID: GO:1901362 +Term: organic cyclic compound biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of organic cyclic compound. +-------------------------------------- +GOID: GO:0004364 +Term: glutathione transferase activity +Definition: Catalysis of the reaction: R-X + glutathione = H-X + R-S-glutathione. R may be an aliphatic, aromatic or heterocyclic group; X may be a sulfate, nitrile or halide group. +-------------------------------------- +GOID: GO:0005615 +Term: extracellular space +Definition: That part of a multicellular organism outside the cells proper, usually taken to be outside the plasma membranes, and occupied by fluid. +-------------------------------------- +GOID: GO:0005856 +Term: cytoskeleton +Definition: Any of the various filamentous elements that form the internal framework of cells, and typically remain after treatment of the cells with mild detergent to remove membrane constituents and soluble components of the cytoplasm. The term embraces intermediate filaments, microfilaments, microtubules, the microtrabecular lattice, and other structures characterized by a polymeric filamentous nature and long-range order within the cell. The various elements of the cytoskeleton not only serve in the maintenance of cellular shape but also have roles in other cellular functions, including cellular movement, cell division, endocytosis, and movement of organelles. +-------------------------------------- +GOID: GO:0006732 +Term: coenzyme metabolic process +Definition: The chemical reactions and pathways involving coenzymes, any of various nonprotein organic cofactors that are required, in addition to an enzyme and a substrate, for an enzymatic reaction to proceed. +-------------------------------------- +GOID: GO:0006753 +Term: nucleoside phosphate metabolic process +Definition: The chemical reactions and pathways involving any phosphorylated nucleoside. +-------------------------------------- +GOID: GO:0006811 +Term: ion transport +Definition: The directed movement of charged atoms or small charged molecules into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:0006928 +Term: movement of cell or subcellular component +Definition: The directed, self-propelled movement of a cell or subcellular component without the involvement of an external agent such as a transporter or a pore. +-------------------------------------- +GOID: GO:0009117 +Term: nucleotide metabolic process +Definition: The chemical reactions and pathways involving a nucleotide, a nucleoside that is esterified with (ortho)phosphate or an oligophosphate at any hydroxyl group on the glycose moiety; may be mono-, di- or triphosphate; this definition includes cyclic nucleotides (nucleoside cyclic phosphates). +-------------------------------------- +GOID: GO:0010468 +Term: regulation of gene expression +Definition: Any process that modulates the frequency, rate or extent of gene expression. Gene expression is the process in which a gene's coding sequence is converted into a mature gene product or products (proteins or RNA). This includes the production of an RNA transcript as well as any processing to produce a mature RNA product or an mRNA (for protein-coding genes) and the translation of that mRNA into protein. Protein maturation is included when required to form an active form of a product from an inactive precursor form. +-------------------------------------- +GOID: GO:0010647 +Term: positive regulation of cell communication +Definition: Any process that increases the frequency, rate or extent of cell communication. Cell communication is the process that mediates interactions between a cell and its surroundings. Encompasses interactions such as signaling or attachment between one cell and another cell, between a cell and an extracellular matrix, or between a cell and any other aspect of its environment. +-------------------------------------- +GOID: GO:0010648 +Term: negative regulation of cell communication +Definition: Any process that decreases the frequency, rate or extent of cell communication. Cell communication is the process that mediates interactions between a cell and its surroundings. Encompasses interactions such as signaling or attachment between one cell and another cell, between a cell and an extracellular matrix, or between a cell and any other aspect of its environment. +-------------------------------------- +GOID: GO:0016765 +Term: transferase activity, transferring alkyl or aryl (other than methyl) groups +Definition: Catalysis of the transfer of an alkyl or aryl (but not methyl) group from one compound (donor) to another (acceptor). +-------------------------------------- +GOID: GO:0018130 +Term: heterocycle biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of heterocyclic compounds, those with a cyclic molecular structure and at least two different atoms in the ring (or rings). +-------------------------------------- +GOID: GO:0019693 +Term: ribose phosphate metabolic process +Definition: The chemical reactions and pathways involving ribose phosphate, any phosphorylated ribose sugar. +-------------------------------------- +GOID: GO:0023056 +Term: positive regulation of signaling +Definition: Any process that activates, maintains or increases the frequency, rate or extent of a signaling process. +-------------------------------------- +GOID: GO:0023057 +Term: negative regulation of signaling +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of a signaling process. +-------------------------------------- +GOID: GO:0031326 +Term: regulation of cellular biosynthetic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways resulting in the formation of substances, carried out by individual cells. +-------------------------------------- +GOID: GO:0031967 +Term: organelle envelope +Definition: A double membrane structure enclosing an organelle, including two lipid bilayers and the region between them. In some cases, an organelle envelope may have more than two membranes. +-------------------------------------- +GOID: GO:0031975 +Term: envelope +Definition: A multilayered structure surrounding all or part of a cell; encompasses one or more lipid bilayers, and may include a cell wall layer; also includes the space between layers. +-------------------------------------- +GOID: GO:0032940 +Term: secretion by cell +Definition: The controlled release of a substance by a cell. +-------------------------------------- +GOID: GO:0034654 +Term: nucleobase-containing compound biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of nucleobases, nucleosides, nucleotides and nucleic acids. +-------------------------------------- +GOID: GO:0036094 +Term: small molecule binding +Definition: Interacting selectively and non-covalently with a small molecule, any low molecular weight, monomeric, non-encoded molecule. +-------------------------------------- +GOID: GO:0040011 +Term: locomotion +Definition: Self-propelled movement of a cell or organism from one location to another. +-------------------------------------- +GOID: GO:0042592 +Term: homeostatic process +Definition: Any biological process involved in the maintenance of an internal steady state. +-------------------------------------- +GOID: GO:0042981 +Term: regulation of apoptotic process +Definition: Any process that modulates the occurrence or rate of cell death by apoptotic process. +-------------------------------------- +GOID: GO:0043067 +Term: regulation of programmed cell death +Definition: Any process that modulates the frequency, rate or extent of programmed cell death, cell death resulting from activation of endogenous cellular processes. +-------------------------------------- +GOID: GO:0046903 +Term: secretion +Definition: The controlled release of a substance by a cell or a tissue. +-------------------------------------- +GOID: GO:0048584 +Term: positive regulation of response to stimulus +Definition: Any process that activates, maintains or increases the rate of a response to a stimulus. Response to stimulus is a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. +-------------------------------------- +GOID: GO:0048870 +Term: cell motility +Definition: Any process involved in the controlled self-propelled movement of a cell that results in translocation of the cell from one place to another. +-------------------------------------- +GOID: GO:0051046 +Term: regulation of secretion +Definition: Any process that modulates the frequency, rate or extent of the controlled release of a substance from a cell or a tissue. +-------------------------------------- +GOID: GO:0051094 +Term: positive regulation of developmental process +Definition: Any process that activates or increases the rate or extent of development, the biological process whose specific outcome is the progression of an organism over time from an initial condition (e.g. a zygote, or a young adult) to a later condition (e.g. a multicellular animal or an aged adult). +-------------------------------------- +GOID: GO:0051171 +Term: regulation of nitrogen compound metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving nitrogen or nitrogenous compounds. +-------------------------------------- +GOID: GO:0051186 +Term: cofactor metabolic process +Definition: The chemical reactions and pathways involving a cofactor, a substance that is required for the activity of an enzyme or other protein. Cofactors may be inorganic, such as the metal atoms zinc, iron, and copper in certain forms, or organic, in which case they are referred to as coenzymes. Cofactors may either be bound tightly to active sites or bind loosely with the substrate. +-------------------------------------- +GOID: GO:0051223 +Term: regulation of protein transport +Definition: Any process that modulates the frequency, rate or extent of the directed movement of a protein into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:0051240 +Term: positive regulation of multicellular organismal process +Definition: Any process that activates or increases the frequency, rate or extent of an organismal process, any of the processes pertinent to the function of an organism above the cellular level; includes the integrated processes of tissues and organs. +-------------------------------------- +GOID: GO:0051674 +Term: localization of cell +Definition: Any process in which a cell is transported to, and/or maintained in, a specific location. +-------------------------------------- +GOID: GO:0051704 +Term: multi-organism process +Definition: A biological process which involves another organism of the same or different species. +-------------------------------------- +GOID: GO:0051960 +Term: regulation of nervous system development +Definition: Any process that modulates the frequency, rate or extent of nervous system development, the origin and formation of nervous tissue. +-------------------------------------- +GOID: GO:0055086 +Term: nucleobase-containing small molecule metabolic process +Definition: The cellular chemical reactions and pathways involving a nucleobase-containing small molecule: a nucleobase, a nucleoside, or a nucleotide. +-------------------------------------- +GOID: GO:0070201 +Term: regulation of establishment of protein localization +Definition: Any process that modulates the frequency, rate or extent of the directed movement of a protein to a specific location. +-------------------------------------- +GOID: GO:0090304 +Term: nucleic acid metabolic process +Definition: Any cellular metabolic process involving nucleic acids. +-------------------------------------- +GOID: GO:0097367 +Term: carbohydrate derivative binding +Definition: Interacting selectively and non-covalently with a carbohydrate derivative. +-------------------------------------- +GOID: GO:1901701 +Term: cellular response to oxygen-containing compound +Definition: Any process that results in a change in state or activity of a cell (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an oxygen-containing compound stimulus. +-------------------------------------- +GOID: GO:1903530 +Term: regulation of secretion by cell +Definition: Any process that modulates the frequency, rate or extent of secretion by cell. +-------------------------------------- +GOID: GO:0001568 +Term: blood vessel development +Definition: The process whose specific outcome is the progression of a blood vessel over time, from its formation to the mature structure. The blood vessel is the vasculature carrying blood. +-------------------------------------- +GOID: GO:0001775 +Term: cell activation +Definition: A change in the morphology or behavior of a cell resulting from exposure to an activating factor such as a cellular or soluble ligand. +-------------------------------------- +GOID: GO:0001932 +Term: regulation of protein phosphorylation +Definition: Any process that modulates the frequency, rate or extent of addition of phosphate groups into an amino acid in a protein. +-------------------------------------- +GOID: GO:0001944 +Term: vasculature development +Definition: The process whose specific outcome is the progression of the vasculature over time, from its formation to the mature structure. The vasculature is an interconnected tubular multi-tissue structure that contains fluid that is actively transported around the organism. +-------------------------------------- +GOID: GO:0005509 +Term: calcium ion binding +Definition: Interacting selectively and non-covalently with calcium ions (Ca2+). +-------------------------------------- +GOID: GO:0005740 +Term: mitochondrial envelope +Definition: The double lipid bilayer enclosing the mitochondrion and separating its contents from the cell cytoplasm; includes the intermembrane space. +-------------------------------------- +GOID: GO:0005773 +Term: vacuole +Definition: A closed structure, found only in eukaryotic cells, that is completely surrounded by unit membrane and contains liquid material. Cells contain one or several vacuoles, that may have different functions from each other. Vacuoles have a diverse array of functions. They can act as a storage organelle for nutrients or waste products, as a degradative compartment, as a cost-effective way of increasing cell size, and as a homeostatic regulator controlling both turgor pressure and pH of the cytosol. +-------------------------------------- +GOID: GO:0005887 +Term: integral component of plasma membrane +Definition: The component of the plasma membrane consisting of the gene products and protein complexes having at least some part of their peptide sequence embedded in the hydrophobic region of the membrane. +-------------------------------------- +GOID: GO:0006163 +Term: purine nucleotide metabolic process +Definition: The chemical reactions and pathways involving a purine nucleotide, a compound consisting of nucleoside (a purine base linked to a deoxyribose or ribose sugar) esterified with a phosphate group at either the 3' or 5'-hydroxyl group of the sugar. +-------------------------------------- +GOID: GO:0006468 +Term: protein phosphorylation +Definition: The process of introducing a phosphate group on to a protein. +-------------------------------------- +GOID: GO:0006996 +Term: organelle organization +Definition: A process that is carried out at the cellular level which results in the assembly, arrangement of constituent parts, or disassembly of an organelle within a cell. An organelle is an organized structure of distinctive morphology and function. Includes the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0008610 +Term: lipid biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of lipids, compounds soluble in an organic solvent but not, or sparingly, in an aqueous solvent. +-------------------------------------- +GOID: GO:0009116 +Term: nucleoside metabolic process +Definition: The chemical reactions and pathways involving a nucleoside, a nucleobase linked to either beta-D-ribofuranose (a ribonucleoside) or 2-deoxy-beta-D-ribofuranose, (a deoxyribonucleoside), e.g. adenosine, guanosine, inosine, cytidine, uridine and deoxyadenosine, deoxyguanosine, deoxycytidine and thymidine (= deoxythymidine). +-------------------------------------- +GOID: GO:0009119 +Term: ribonucleoside metabolic process +Definition: The chemical reactions and pathways involving any ribonucleoside, a nucleoside in which purine or pyrimidine base is linked to a ribose (beta-D-ribofuranose) molecule. +-------------------------------------- +GOID: GO:0009123 +Term: nucleoside monophosphate metabolic process +Definition: The chemical reactions and pathways involving a nucleoside monophosphate, a compound consisting of a nucleobase linked to a deoxyribose or ribose sugar esterified with phosphate on the sugar. +-------------------------------------- +GOID: GO:0009126 +Term: purine nucleoside monophosphate metabolic process +Definition: The chemical reactions and pathways involving purine nucleoside monophosphate, a compound consisting of a purine base linked to a ribose or deoxyribose sugar esterified with phosphate on the sugar. +-------------------------------------- +GOID: GO:0009141 +Term: nucleoside triphosphate metabolic process +Definition: The chemical reactions and pathways involving a nucleoside triphosphate, a compound consisting of a nucleobase linked to a deoxyribose or ribose sugar esterified with triphosphate on the sugar. +-------------------------------------- +GOID: GO:0009144 +Term: purine nucleoside triphosphate metabolic process +Definition: The chemical reactions and pathways involving purine nucleoside triphosphate, a compound consisting of a purine base linked to a ribose or deoxyribose sugar esterified with triphosphate on the sugar. +-------------------------------------- +GOID: GO:0009150 +Term: purine ribonucleotide metabolic process +Definition: The chemical reactions and pathways involving a purine ribonucleotide, a compound consisting of ribonucleoside (a purine base linked to a ribose sugar) esterified with a phosphate group at either the 3' or 5'-hydroxyl group of the sugar. +-------------------------------------- +GOID: GO:0009161 +Term: ribonucleoside monophosphate metabolic process +Definition: The chemical reactions and pathways involving a ribonucleoside monophosphate, a compound consisting of a nucleobase linked to a ribose sugar esterified with phosphate on the sugar. +-------------------------------------- +GOID: GO:0009167 +Term: purine ribonucleoside monophosphate metabolic process +Definition: The chemical reactions and pathways involving purine ribonucleoside monophosphate, a compound consisting of a purine base linked to a ribose sugar esterified with phosphate on the sugar. +-------------------------------------- +GOID: GO:0009199 +Term: ribonucleoside triphosphate metabolic process +Definition: The chemical reactions and pathways involving a ribonucleoside triphosphate, a compound consisting of a nucleobase linked to a ribose sugar esterified with triphosphate on the sugar. +-------------------------------------- +GOID: GO:0009205 +Term: purine ribonucleoside triphosphate metabolic process +Definition: The chemical reactions and pathways involving purine ribonucleoside triphosphate, a compound consisting of a purine base linked to a ribose sugar esterified with triphosphate on the sugar. +-------------------------------------- +GOID: GO:0009259 +Term: ribonucleotide metabolic process +Definition: The chemical reactions and pathways involving a ribonucleotide, a compound consisting of ribonucleoside (a base linked to a ribose sugar) esterified with a phosphate group at either the 3' or 5'-hydroxyl group of the sugar. +-------------------------------------- +GOID: GO:0009306 +Term: protein secretion +Definition: The controlled release of proteins from a cell. +-------------------------------------- +GOID: GO:0009891 +Term: positive regulation of biosynthetic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways resulting in the formation of substances. +-------------------------------------- +GOID: GO:0009892 +Term: negative regulation of metabolic process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of the chemical reactions and pathways within a cell or an organism. +-------------------------------------- +GOID: GO:0009967 +Term: positive regulation of signal transduction +Definition: Any process that activates or increases the frequency, rate or extent of signal transduction. +-------------------------------------- +GOID: GO:0010556 +Term: regulation of macromolecule biosynthetic process +Definition: Any process that modulates the rate, frequency or extent of the chemical reactions and pathways resulting in the formation of a macromolecule, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0010605 +Term: negative regulation of macromolecule metabolic process +Definition: Any process that decreases the frequency, rate or extent of the chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0010876 +Term: lipid localization +Definition: Any process in which a lipid is transported to, or maintained in, a specific location. +-------------------------------------- +GOID: GO:0016070 +Term: RNA metabolic process +Definition: The cellular chemical reactions and pathways involving RNA, ribonucleic acid, one of the two main type of nucleic acid, consisting of a long, unbranched macromolecule formed from ribonucleotides joined in 3',5'-phosphodiester linkage. +-------------------------------------- +GOID: GO:0016477 +Term: cell migration +Definition: The controlled self-propelled movement of a cell from one site to a destination guided by molecular cues. Cell migration is a central process in the development and maintenance of multicellular organisms. +-------------------------------------- +GOID: GO:0016788 +Term: hydrolase activity, acting on ester bonds +Definition: Catalysis of the hydrolysis of any ester bond. +-------------------------------------- +GOID: GO:0019219 +Term: regulation of nucleobase-containing compound metabolic process +Definition: Any cellular process that modulates the frequency, rate or extent of the chemical reactions and pathways involving nucleobases, nucleosides, nucleotides and nucleic acids. +-------------------------------------- +GOID: GO:0019220 +Term: regulation of phosphate metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving phosphates. +-------------------------------------- +GOID: GO:0031012 +Term: extracellular matrix +Definition: A structure lying external to one or more cells, which provides structural support for cells or tissues. +-------------------------------------- +GOID: GO:0031226 +Term: intrinsic component of plasma membrane +Definition: The component of the plasma membrane consisting of the gene products and protein complexes having either part of their peptide sequence embedded in the hydrophobic region of the membrane or some other covalently attached group such as a GPI anchor that is similarly embedded in the membrane. +-------------------------------------- +GOID: GO:0031324 +Term: negative regulation of cellular metabolic process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of the chemical reactions and pathways by which individual cells transform chemical substances. +-------------------------------------- +GOID: GO:0031399 +Term: regulation of protein modification process +Definition: Any process that modulates the frequency, rate or extent of the covalent alteration of one or more amino acid residues within a protein. +-------------------------------------- +GOID: GO:0035295 +Term: tube development +Definition: The process whose specific outcome is the progression of a tube over time, from its initial formation to a mature structure. Epithelial and endothelial tubes transport gases, liquids and cells from one site to another and form the basic structure of many organs and tissues including lung and trachea, kidney, the mammary gland, the vascular system and the gastrointestinal and urinary-genital tracts. +-------------------------------------- +GOID: GO:0042127 +Term: regulation of cell proliferation +Definition: Any process that modulates the frequency, rate or extent of cell proliferation. +-------------------------------------- +GOID: GO:0042278 +Term: purine nucleoside metabolic process +Definition: The chemical reactions and pathways involving one of a family of organic molecules consisting of a purine base covalently bonded to a sugar ribose (a ribonucleoside) or deoxyribose (a deoxyribonucleoside). +-------------------------------------- +GOID: GO:0042325 +Term: regulation of phosphorylation +Definition: Any process that modulates the frequency, rate or extent of addition of phosphate groups into a molecule. +-------------------------------------- +GOID: GO:0043933 +Term: macromolecular complex subunit organization +Definition: Any process in which macromolecules aggregate, disaggregate, or are modified, resulting in the formation, disassembly, or alteration of a macromolecular complex. +-------------------------------------- +GOID: GO:0044429 +Term: mitochondrial part +Definition: Any constituent part of a mitochondrion, a semiautonomous, self replicating organelle that occurs in varying numbers, shapes, and sizes in the cytoplasm of virtually all eukaryotic cells. It is notably the site of tissue respiration. +-------------------------------------- +GOID: GO:0044432 +Term: endoplasmic reticulum part +Definition: Any constituent part of the endoplasmic reticulum, the irregular network of unit membranes, visible only by electron microscopy, that occurs in the cytoplasm of many eukaryotic cells. The membranes form a complex meshwork of tubular channels, which are often expanded into slitlike cavities called cisternae. +-------------------------------------- +GOID: GO:0045664 +Term: regulation of neuron differentiation +Definition: Any process that modulates the frequency, rate or extent of neuron differentiation. +-------------------------------------- +GOID: GO:0046034 +Term: ATP metabolic process +Definition: The chemical reactions and pathways involving ATP, adenosine triphosphate, a universally important coenzyme and enzyme regulator. +-------------------------------------- +GOID: GO:0046128 +Term: purine ribonucleoside metabolic process +Definition: The chemical reactions and pathways involving any ribonucleoside, a nucleoside in which purine base is linked to a ribose (beta-D-ribofuranose) molecule. +-------------------------------------- +GOID: GO:0046983 +Term: protein dimerization activity +Definition: The formation of a protein dimer, a macromolecular structure consists of two noncovalently associated identical or nonidentical subunits. +-------------------------------------- +GOID: GO:0048514 +Term: blood vessel morphogenesis +Definition: The process in which the anatomical structures of blood vessels are generated and organized. The blood vessel is the vasculature carrying blood. +-------------------------------------- +GOID: GO:0048585 +Term: negative regulation of response to stimulus +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of a response to a stimulus. Response to stimulus is a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. +-------------------------------------- +GOID: GO:0048646 +Term: anatomical structure formation involved in morphogenesis +Definition: The developmental process pertaining to the initial formation of an anatomical structure from unspecified parts. This process begins with the specific processes that contribute to the appearance of the discrete structure and ends when the structural rudiment is recognizable. An anatomical structure is any biological entity that occupies space and is distinguished from its surroundings. Anatomical structures can be macroscopic such as a carpel, or microscopic such as an acrosome. +-------------------------------------- +GOID: GO:0048666 +Term: neuron development +Definition: The process whose specific outcome is the progression of a neuron over time, from initial commitment of the cell to a specific fate, to the fully functional differentiated cell. +-------------------------------------- +GOID: GO:0050708 +Term: regulation of protein secretion +Definition: Any process that modulates the frequency, rate or extent of the controlled release of a protein from a cell. +-------------------------------------- +GOID: GO:0050767 +Term: regulation of neurogenesis +Definition: Any process that modulates the frequency, rate or extent of neurogenesis, the origin and formation of neurons. +-------------------------------------- +GOID: GO:0051050 +Term: positive regulation of transport +Definition: Any process that activates or increases the frequency, rate or extent of the directed movement of substances (such as macromolecules, small molecules, ions) into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:0051093 +Term: negative regulation of developmental process +Definition: Any process that stops, prevents or reduces the rate or extent of development, the biological process whose specific outcome is the progression of an organism over time from an initial condition (e.g. a zygote, or a young adult) to a later condition (e.g. a multicellular animal or an aged adult). +-------------------------------------- +GOID: GO:0051174 +Term: regulation of phosphorus metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving phosphorus or compounds containing phosphorus. +-------------------------------------- +GOID: GO:0051247 +Term: positive regulation of protein metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways involving a protein. +-------------------------------------- +GOID: GO:0051641 +Term: cellular localization +Definition: A localization process that takes place at the cellular level; as a result of a cellular localization process, a substance or cellular entity, such as a protein complex or organelle, is transported to, and/or maintained in, a specific location within or in the membrane of a cell. +-------------------------------------- +GOID: GO:0051649 +Term: establishment of localization in cell +Definition: Any process, occuring in a cell, that localizes a substance or cellular component. This may occur via movement, tethering or selective degradation. +-------------------------------------- +GOID: GO:0060284 +Term: regulation of cell development +Definition: Any process that modulates the rate, frequency or extent of the progression of the cell over time, from its formation to the mature structure. Cell development does not include the steps involved in committing a cell to a specific fate. +-------------------------------------- +GOID: GO:0060548 +Term: negative regulation of cell death +Definition: Any process that decreases the rate or frequency of cell death. Cell death is the specific activation or halting of processes within a cell so that its vital functions markedly cease, rather than simply deteriorating gradually over time, which culminates in cell death. +-------------------------------------- +GOID: GO:0065003 +Term: macromolecular complex assembly +Definition: The aggregation, arrangement and bonding together of a set of macromolecules to form a complex. +-------------------------------------- +GOID: GO:0065009 +Term: regulation of molecular function +Definition: Any process that modulates the frequency, rate or extent of a molecular function, an elemental biological activity occurring at the molecular level, such as catalysis or binding. +-------------------------------------- +GOID: GO:0072358 +Term: cardiovascular system development +Definition: The process whose specific outcome is the progression of the cardiovascular system over time, from its formation to the mature structure. The cardiovascular system is the anatomical system that has as its parts the heart and blood vessels. +-------------------------------------- +GOID: GO:0072359 +Term: circulatory system development +Definition: The process whose specific outcome is the progression of the circulatory system over time, from its formation to the mature structure. The circulatory system is the organ system that passes nutrients (such as amino acids and electrolytes), gases, hormones, blood cells, etc. to and from cells in the body to help fight diseases and help stabilize body temperature and pH to maintain homeostasis. +-------------------------------------- +GOID: GO:0072521 +Term: purine-containing compound metabolic process +Definition: The chemical reactions and pathways involving a purine-containing compound, i.e. any compound that contains purine or a formal derivative thereof. +-------------------------------------- +GOID: GO:0097190 +Term: apoptotic signaling pathway +Definition: A series of molecular signals which triggers the apoptotic death of a cell. The pathway starts with reception of a signal, and ends when the execution phase of apoptosis is triggered. +-------------------------------------- +GOID: GO:0098796 +Term: membrane protein complex +Definition: Any protein complex that is part of a membrane. +-------------------------------------- +GOID: GO:1901657 +Term: glycosyl compound metabolic process +Definition: The chemical reactions and pathways involving glycosyl compound. +-------------------------------------- +GOID: GO:2000112 +Term: regulation of cellular macromolecule biosynthetic process +Definition: Any process that modulates the frequency, rate or extent of cellular macromolecule biosynthetic process. +-------------------------------------- + +-------------------------------------- +cluster: 2 +-------------------------------------- + +-------------------------------------- +GOID: GO:0003674 +Term: molecular_function +Definition: Elemental activities, such as catalysis or binding, describing the actions of a gene product at the molecular level. A given gene product may exhibit one or more molecular functions. +-------------------------------------- +GOID: GO:0005575 +Term: cellular_component +Definition: The part of a cell or its extracellular environment in which a gene product is located. A gene product may be located in one or more parts of a cell and its location may be as specific as a particular macromolecular complex, that is, a stable, persistent association of macromolecules that function together. +-------------------------------------- +GOID: GO:0008150 +Term: biological_process +Definition: Any process specifically pertinent to the functioning of integrated living units: cells, tissues, organs, and organisms. A process is a collection of molecular events with a defined beginning and end. +-------------------------------------- +GOID: GO:0005623 +Term: cell +Definition: The basic structural and functional unit of all organisms. Includes the plasma membrane and any external encapsulating structures such as the cell wall and cell envelope. +-------------------------------------- +GOID: GO:0044464 +Term: cell part +Definition: Any constituent part of a cell, the basic structural and functional unit of all organisms. +-------------------------------------- +GOID: GO:0005622 +Term: intracellular +Definition: The living contents of a cell; the matter contained within (but not including) the plasma membrane, usually taken to exclude large vacuoles and masses of secretory or ingested material. In eukaryotes it includes the nucleus and cytoplasm. +-------------------------------------- +GOID: GO:0044424 +Term: intracellular part +Definition: Any constituent part of the living contents of a cell; the matter contained within (but not including) the plasma membrane, usually taken to exclude large vacuoles and masses of secretory or ingested material. In eukaryotes it includes the nucleus and cytoplasm. +-------------------------------------- +GOID: GO:0009987 +Term: cellular process +Definition: Any process that is carried out at the cellular level, but not necessarily restricted to a single cell. For example, cell communication occurs among more than one cell, but occurs at the cellular level. +-------------------------------------- +GOID: GO:0044699 +Term: single-organism process +Definition: A biological process that involves only one organism. +-------------------------------------- +GOID: GO:0043226 +Term: organelle +Definition: Organized structure of distinctive morphology and function. Includes the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton, and prokaryotic structures such as anammoxosomes and pirellulosomes. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0008152 +Term: metabolic process +Definition: The chemical reactions and pathways, including anabolism and catabolism, by which living organisms transform chemical substances. Metabolic processes typically transform small molecules, but also include macromolecular processes such as DNA repair and replication, and protein synthesis and degradation. +-------------------------------------- +GOID: GO:0043227 +Term: membrane-bounded organelle +Definition: Organized structure of distinctive morphology and function, bounded by a single or double lipid bilayer membrane. Includes the nucleus, mitochondria, plastids, vacuoles, and vesicles. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0043229 +Term: intracellular organelle +Definition: Organized structure of distinctive morphology and function, occurring within the cell. Includes the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0005737 +Term: cytoplasm +Definition: All of the contents of a cell excluding the plasma membrane and nucleus, but including other subcellular structures. +-------------------------------------- +GOID: GO:0043231 +Term: intracellular membrane-bounded organelle +Definition: Organized structure of distinctive morphology and function, bounded by a single or double lipid bilayer membrane and occurring within the cell. Includes the nucleus, mitochondria, plastids, vacuoles, and vesicles. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0071704 +Term: organic substance metabolic process +Definition: The chemical reactions and pathways involving an organic substance, any molecular entity containing carbon. +-------------------------------------- +GOID: GO:0044238 +Term: primary metabolic process +Definition: The chemical reactions and pathways involving those compounds which are formed as a part of the normal anabolic and catabolic processes. These processes take place in most, if not all, cells of the organism. +-------------------------------------- +GOID: GO:0044763 +Term: single-organism cellular process +Definition: Any process that is carried out at the cellular level, occurring within a single organism. +-------------------------------------- +GOID: GO:0044237 +Term: cellular metabolic process +Definition: The chemical reactions and pathways by which individual cells transform chemical substances. +-------------------------------------- +GOID: GO:0005488 +Term: binding +Definition: The selective, non-covalent, often stoichiometric, interaction of a molecule with one or more specific sites on another molecule. +-------------------------------------- +GOID: GO:0003824 +Term: catalytic activity +Definition: Catalysis of a biochemical reaction at physiological temperatures. In biologically catalyzed reactions, the reactants are known as substrates, and the catalysts are naturally occurring macromolecular substances known as enzymes. Enzymes possess specific binding sites for substrates, and are usually composed wholly or largely of protein, but RNA that has catalytic activity (ribozyme) is often also regarded as enzymatic. +-------------------------------------- +GOID: GO:0044444 +Term: cytoplasmic part +Definition: Any constituent part of the cytoplasm, all of the contents of a cell excluding the plasma membrane and nucleus, but including other subcellular structures. +-------------------------------------- +GOID: GO:0044710 +Term: single-organism metabolic process +Definition: A metabolic process - chemical reactions and pathways, including anabolism and catabolism, by which living organisms transform chemical substances - which involves a single organism. +-------------------------------------- +GOID: GO:0044422 +Term: organelle part +Definition: Any constituent part of an organelle, an organized structure of distinctive morphology and function. Includes constituent parts of the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton, but excludes the plasma membrane. +-------------------------------------- +GOID: GO:0044446 +Term: intracellular organelle part +Definition: A constituent part of an intracellular organelle, an organized structure of distinctive morphology and function, occurring within the cell. Includes constituent parts of the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton but excludes the plasma membrane. +-------------------------------------- +GOID: GO:0044281 +Term: small molecule metabolic process +Definition: The chemical reactions and pathways involving small molecules, any low molecular weight, monomeric, non-encoded molecule. +-------------------------------------- +GOID: GO:0050789 +Term: regulation of biological process +Definition: Any process that modulates the frequency, rate or extent of a biological process. Biological processes are regulated by many means; examples include the control of gene expression, protein modification or interaction with a protein or substrate molecule. +-------------------------------------- +GOID: GO:0050794 +Term: regulation of cellular process +Definition: Any process that modulates the frequency, rate or extent of a cellular process, any of those that are carried out at the cellular level, but are not necessarily restricted to a single cell. For example, cell communication occurs among more than one cell, but occurs at the cellular level. +-------------------------------------- +GOID: GO:0050896 +Term: response to stimulus +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. The process begins with detection of the stimulus and ends with a change in state or activity or the cell or organism. +-------------------------------------- +GOID: GO:0065007 +Term: biological regulation +Definition: Any process that modulates a measurable attribute of any biological process, quality or function. +-------------------------------------- +GOID: GO:0005634 +Term: nucleus +Definition: A membrane-bounded organelle of eukaryotic cells in which chromosomes are housed and replicated. In most cells, the nucleus contains all of the cell's chromosomes except the organellar chromosomes, and is the site of RNA synthesis and processing. In some species, or in specialized cell types, RNA metabolism or DNA replication may be absent. +-------------------------------------- +GOID: GO:0016020 +Term: membrane +Definition: A lipid bilayer along with all the proteins and protein complexes embedded in it an attached to it. +-------------------------------------- +GOID: GO:0043170 +Term: macromolecule metabolic process +Definition: The chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0044260 +Term: cellular macromolecule metabolic process +Definition: The chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass, as carried out by individual cells. +-------------------------------------- +GOID: GO:0005515 +Term: protein binding +Definition: Interacting selectively and non-covalently with any protein or protein complex (a complex of two or more proteins that may include other nonprotein molecules). +-------------------------------------- +GOID: GO:0006807 +Term: nitrogen compound metabolic process +Definition: The chemical reactions and pathways involving organic or inorganic compounds that contain nitrogen, including (but not limited to) nitrogen fixation, nitrification, denitrification, assimilatory/dissimilatory nitrate reduction and the interconversion of nitrogenous organic matter and ammonium. +-------------------------------------- +GOID: GO:0031974 +Term: membrane-enclosed lumen +Definition: The enclosed volume within a sealed membrane or between two sealed membranes. Encompasses the volume enclosed by the membranes of a particular organelle, e.g. endoplasmic reticulum lumen, or the space between the two lipid bilayers of a double membrane surrounding an organelle, e.g. nuclear envelope lumen. +-------------------------------------- +GOID: GO:0043233 +Term: organelle lumen +Definition: The internal volume enclosed by the membranes of a particular organelle; includes the volume enclosed by a single organelle membrane, e.g. endoplasmic reticulum lumen, or the volume enclosed by the innermost of the two lipid bilayers of an organelle envelope, e.g. nuclear lumen. +-------------------------------------- +GOID: GO:0051716 +Term: cellular response to stimulus +Definition: Any process that results in a change in state or activity of a cell (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. The process begins with detection of the stimulus by a cell and ends with a change in state or activity or the cell. +-------------------------------------- +GOID: GO:0055114 +Term: oxidation-reduction process +Definition: A metabolic process that results in the removal or addition of one or more electrons to or from a substance, with or without the concomitant removal or addition of a proton or protons. +-------------------------------------- +GOID: GO:0070013 +Term: intracellular organelle lumen +Definition: An organelle lumen that is part of an intracellular organelle. +-------------------------------------- +GOID: GO:0006082 +Term: organic acid metabolic process +Definition: The chemical reactions and pathways involving organic acids, any acidic compound containing carbon in covalent linkage. +-------------------------------------- +GOID: GO:0097159 +Term: organic cyclic compound binding +Definition: Interacting selectively and non-covalently with an organic cyclic compound, any molecular entity that contains carbon arranged in a cyclic molecular structure. +-------------------------------------- +GOID: GO:0006629 +Term: lipid metabolic process +Definition: The chemical reactions and pathways involving lipids, compounds soluble in an organic solvent but not, or sparingly, in an aqueous solvent. Includes fatty acids; neutral fats, other fatty-acid esters, and soaps; long-chain (fatty) alcohols and waxes; sphingoids and other long-chain bases; glycolipids, phospholipids and sphingolipids; and carotenes, polyprenols, sterols, terpenes and other isoprenoids. +-------------------------------------- +GOID: GO:0019752 +Term: carboxylic acid metabolic process +Definition: The chemical reactions and pathways involving carboxylic acids, any organic acid containing one or more carboxyl (COOH) groups or anions (COO-). +-------------------------------------- +GOID: GO:0034641 +Term: cellular nitrogen compound metabolic process +Definition: The chemical reactions and pathways involving various organic and inorganic nitrogenous compounds, as carried out by individual cells. +-------------------------------------- +GOID: GO:0043436 +Term: oxoacid metabolic process +Definition: The chemical reactions and pathways involving any oxoacid; an oxoacid is a compound which contains oxygen, at least one other element, and at least one hydrogen bound to oxygen, and which produces a conjugate base by loss of positive hydrogen ion(s) (hydrons). +-------------------------------------- +GOID: GO:1901360 +Term: organic cyclic compound metabolic process +Definition: The chemical reactions and pathways involving organic cyclic compound. +-------------------------------------- +GOID: GO:1901363 +Term: heterocyclic compound binding +Definition: Interacting selectively and non-covalently with heterocyclic compound. +-------------------------------------- +GOID: GO:0005739 +Term: mitochondrion +Definition: A semiautonomous, self replicating organelle that occurs in varying numbers, shapes, and sizes in the cytoplasm of virtually all eukaryotic cells. It is notably the site of tissue respiration. +-------------------------------------- +GOID: GO:0006139 +Term: nucleobase-containing compound metabolic process +Definition: Any cellular metabolic process involving nucleobases, nucleosides, nucleotides and nucleic acids. +-------------------------------------- +GOID: GO:0006725 +Term: cellular aromatic compound metabolic process +Definition: The chemical reactions and pathways involving aromatic compounds, any organic compound characterized by one or more planar rings, each of which contains conjugated double bonds and delocalized pi electrons, as carried out by individual cells. +-------------------------------------- +GOID: GO:0009058 +Term: biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of substances; typically the energy-requiring part of metabolism in which simpler substances are transformed into more complex ones. +-------------------------------------- +GOID: GO:0019222 +Term: regulation of metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways within a cell or an organism. +-------------------------------------- +GOID: GO:0031323 +Term: regulation of cellular metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways by which individual cells transform chemical substances. +-------------------------------------- +GOID: GO:0032787 +Term: monocarboxylic acid metabolic process +Definition: The chemical reactions and pathways involving monocarboxylic acids, any organic acid containing one carboxyl (COOH) group or anion (COO-). +-------------------------------------- +GOID: GO:0042221 +Term: response to chemical +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a chemical stimulus. +-------------------------------------- +GOID: GO:0044255 +Term: cellular lipid metabolic process +Definition: The chemical reactions and pathways involving lipids, as carried out by individual cells. +-------------------------------------- +GOID: GO:0044425 +Term: membrane part +Definition: Any constituent part of a membrane, a double layer of lipid molecules that encloses all cells, and, in eukaryotes, many organelles; may be a single or double lipid bilayer; also includes associated proteins. +-------------------------------------- +GOID: GO:0046483 +Term: heterocycle metabolic process +Definition: The chemical reactions and pathways involving heterocyclic compounds, those with a cyclic molecular structure and at least two different atoms in the ring (or rings). +-------------------------------------- +GOID: GO:0080090 +Term: regulation of primary metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways within a cell or an organism involving those compounds formed as a part of the normal anabolic and catabolic processes. These processes take place in most, if not all, cells of the organism. +-------------------------------------- +GOID: GO:1901576 +Term: organic substance biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of an organic substance, any molecular entity containing carbon. +-------------------------------------- +GOID: GO:0005576 +Term: extracellular region +Definition: The space external to the outermost structure of a cell. For cells without external protective or external encapsulating structures this refers to space outside of the plasma membrane. This term covers the host cell environment outside an intracellular parasite. +-------------------------------------- +GOID: GO:0006631 +Term: fatty acid metabolic process +Definition: The chemical reactions and pathways involving fatty acids, aliphatic monocarboxylic acids liberated from naturally occurring fats and oils by hydrolysis. +-------------------------------------- +GOID: GO:0006793 +Term: phosphorus metabolic process +Definition: The chemical reactions and pathways involving the nonmetallic element phosphorus or compounds that contain phosphorus, usually in the form of a phosphate group (PO4). +-------------------------------------- +GOID: GO:0006796 +Term: phosphate-containing compound metabolic process +Definition: The chemical reactions and pathways involving the phosphate group, the anion or salt of any phosphoric acid. +-------------------------------------- +GOID: GO:0007154 +Term: cell communication +Definition: Any process that mediates interactions between a cell and its surroundings. Encompasses interactions such as signaling or attachment between one cell and another cell, between a cell and an extracellular matrix, or between a cell and any other aspect of its environment. +-------------------------------------- +GOID: GO:0016021 +Term: integral component of membrane +Definition: The component of a membrane consisting of the gene products and protein complexes having at least some part of their peptide sequence embedded in the hydrophobic region of the membrane. +-------------------------------------- +GOID: GO:0019538 +Term: protein metabolic process +Definition: The chemical reactions and pathways involving a specific protein, rather than of proteins in general. Includes protein modification. +-------------------------------------- +GOID: GO:0023052 +Term: signaling +Definition: The entirety of a process in which information is transmitted within a biological system. This process begins with an active signal and ends when a cellular response has been triggered. +-------------------------------------- +GOID: GO:0031224 +Term: intrinsic component of membrane +Definition: The component of a membrane consisting of the gene products having some covalently attached portion, for example part of a peptide sequence or some other covalently attached group such as a GPI anchor, which spans or is embedded in one or both leaflets of the membrane. +-------------------------------------- +GOID: GO:0044249 +Term: cellular biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of substances, carried out by individual cells. +-------------------------------------- +GOID: GO:0044267 +Term: cellular protein metabolic process +Definition: The chemical reactions and pathways involving a specific protein, rather than of proteins in general, occurring at the level of an individual cell. Includes cellular protein modification. +-------------------------------------- +GOID: GO:0044421 +Term: extracellular region part +Definition: Any constituent part of the extracellular region, the space external to the outermost structure of a cell. For cells without external protective or external encapsulating structures this refers to space outside of the plasma membrane. This term covers constituent parts of the host cell environment outside an intracellular parasite. +-------------------------------------- +GOID: GO:0044428 +Term: nuclear part +Definition: Any constituent part of the nucleus, a membrane-bounded organelle of eukaryotic cells in which chromosomes are housed and replicated. +-------------------------------------- +GOID: GO:0044700 +Term: single organism signaling +Definition: A signaling process occurring within a single organism. +-------------------------------------- +GOID: GO:1901564 +Term: organonitrogen compound metabolic process +Definition: The chemical reactions and pathways involving organonitrogen compound. +-------------------------------------- +GOID: GO:0007165 +Term: signal transduction +Definition: The cellular process in which a signal is conveyed to trigger a change in the activity or state of a cell. Signal transduction begins with reception of a signal (e.g. a ligand binding to a receptor or receptor activation by a stimulus such as light), or for signal transduction in the absence of ligand, signal-withdrawal or the activity of a constitutively active receptor. Signal transduction ends with regulation of a downstream cellular process, e.g. regulation of transcription or regulation of a metabolic process. Signal transduction covers signaling from receptors located on the surface of the cell and signaling via molecules located within the cell. For signaling between cells, signal transduction is restricted to events at and within the receiving cell. +-------------------------------------- +GOID: GO:0016043 +Term: cellular component organization +Definition: A process that results in the assembly, arrangement of constituent parts, or disassembly of a cellular component. +-------------------------------------- +GOID: GO:0016491 +Term: oxidoreductase activity +Definition: Catalysis of an oxidation-reduction (redox) reaction, a reversible chemical reaction in which the oxidation state of an atom or atoms within a molecule is altered. One substrate acts as a hydrogen or electron donor and becomes oxidized, while the other acts as hydrogen or electron acceptor and becomes reduced. +-------------------------------------- +GOID: GO:0031981 +Term: nuclear lumen +Definition: The volume enclosed by the nuclear inner membrane. +-------------------------------------- +GOID: GO:0031982 +Term: vesicle +Definition: Any small, fluid-filled, spherical organelle enclosed by membrane. +-------------------------------------- +GOID: GO:0031988 +Term: membrane-bounded vesicle +Definition: Any small, fluid-filled, spherical organelle enclosed by a lipid bilayer. +-------------------------------------- +GOID: GO:0032991 +Term: macromolecular complex +Definition: A stable assembly of two or more macromolecules, i.e. proteins, nucleic acids, carbohydrates or lipids, in which the constituent parts function together. +-------------------------------------- +GOID: GO:0048518 +Term: positive regulation of biological process +Definition: Any process that activates or increases the frequency, rate or extent of a biological process. Biological processes are regulated by many means; examples include the control of gene expression, protein modification or interaction with a protein or substrate molecule. +-------------------------------------- +GOID: GO:0048522 +Term: positive regulation of cellular process +Definition: Any process that activates or increases the frequency, rate or extent of a cellular process, any of those that are carried out at the cellular level, but are not necessarily restricted to a single cell. For example, cell communication occurs among more than one cell, but occurs at the cellular level. +-------------------------------------- +GOID: GO:0051179 +Term: localization +Definition: Any process in which a cell, a substance, or a cellular entity, such as a protein complex or organelle, is transported, tethered to or otherwise maintained in a specific location. In the case of substances, localization may also be achieved via selective degradation. +-------------------------------------- +GOID: GO:0071840 +Term: cellular component organization or biogenesis +Definition: A process that results in the biosynthesis of constituent macromolecules, assembly, arrangement of constituent parts, or disassembly of a cellular component. +-------------------------------------- +GOID: GO:0071944 +Term: cell periphery +Definition: The part of a cell encompassing the cell cortex, the plasma membrane, and any external encapsulating structures. +-------------------------------------- +GOID: GO:0005886 +Term: plasma membrane +Definition: The membrane surrounding a cell that separates the cell from its external environment. It consists of a phospholipid bilayer and associated proteins. +-------------------------------------- +GOID: GO:0006810 +Term: transport +Definition: The directed movement of substances (such as macromolecules, small molecules, ions) or cellular components (such as complexes and organelles) into, out of or within a cell, or between cells, or within a multicellular organism by means of some agent such as a transporter, pore or motor protein. +-------------------------------------- +GOID: GO:0032501 +Term: multicellular organismal process +Definition: Any biological process, occurring at the level of a multicellular organism, pertinent to its function. +-------------------------------------- +GOID: GO:0036094 +Term: small molecule binding +Definition: Interacting selectively and non-covalently with a small molecule, any low molecular weight, monomeric, non-encoded molecule. +-------------------------------------- +GOID: GO:0043167 +Term: ion binding +Definition: Interacting selectively and non-covalently with ions, charged atoms or groups of atoms. +-------------------------------------- +GOID: GO:0043228 +Term: non-membrane-bounded organelle +Definition: Organized structure of distinctive morphology and function, not bounded by a lipid bilayer membrane. Includes ribosomes, the cytoskeleton and chromosomes. +-------------------------------------- +GOID: GO:0043230 +Term: extracellular organelle +Definition: Organized structure of distinctive morphology and function, occurring outside the cell. Includes, for example, extracellular membrane vesicles (EMVs) and the cellulosomes of anaerobic bacteria and fungi. +-------------------------------------- +GOID: GO:0043232 +Term: intracellular non-membrane-bounded organelle +Definition: Organized structure of distinctive morphology and function, not bounded by a lipid bilayer membrane and occurring within the cell. Includes ribosomes, the cytoskeleton and chromosomes. +-------------------------------------- +GOID: GO:0043234 +Term: protein complex +Definition: A stable macromolecular complex composed (only) of two or more polypeptide subunits along with any covalently attached molecules (such as lipid anchors or oligosaccharide) or non-protein prosthetic groups (such as nucleotides or metal ions). Prosthetic group in this context refers to a tightly bound cofactor. The component polypeptide subunits may be identical. +-------------------------------------- +GOID: GO:0043412 +Term: macromolecule modification +Definition: The covalent alteration of one or more monomeric units in a polypeptide, polynucleotide, polysaccharide, or other biological macromolecule, resulting in a change in its properties. +-------------------------------------- +GOID: GO:0051234 +Term: establishment of localization +Definition: Any process that localizes a substance or cellular component. This may occur via movement, tethering or selective degradation. +-------------------------------------- +GOID: GO:0060255 +Term: regulation of macromolecule metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0070062 +Term: extracellular exosome +Definition: A membrane-bounded vesicle that is released into the extracellular region by fusion of the limiting endosomal membrane of a multivesicular body with the plasma membrane. Extracellular exosomes, also simply called exosomes, have a diameter of about 40-100 nm. +-------------------------------------- +GOID: GO:1903561 +Term: extracellular vesicle +Definition: Any vesicle that is part of the extracellular region. +-------------------------------------- +GOID: GO:0000166 +Term: nucleotide binding +Definition: Interacting selectively and non-covalently with a nucleotide, any compound consisting of a nucleoside that is esterified with (ortho)phosphate or an oligophosphate at any hydroxyl group on the ribose or deoxyribose. +-------------------------------------- +GOID: GO:0005829 +Term: cytosol +Definition: The part of the cytoplasm that does not contain organelles but which does contain other particulate matter, such as protein complexes. +-------------------------------------- +GOID: GO:0006464 +Term: cellular protein modification process +Definition: The covalent alteration of one or more amino acids occurring in proteins, peptides and nascent polypeptides (co-translational, post-translational modifications) occurring at the level of an individual cell. Includes the modification of charged tRNAs that are destined to occur in a protein (pre-translation modification). +-------------------------------------- +GOID: GO:0006811 +Term: ion transport +Definition: The directed movement of charged atoms or small charged molecules into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:0009056 +Term: catabolic process +Definition: The chemical reactions and pathways resulting in the breakdown of substances, including the breakdown of carbon compounds with the liberation of energy for use by the cell or organism. +-------------------------------------- +GOID: GO:0009893 +Term: positive regulation of metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways within a cell or an organism. +-------------------------------------- +GOID: GO:0012505 +Term: endomembrane system +Definition: A collection of membranous structures involved in transport within the cell. The main components of the endomembrane system are endoplasmic reticulum, Golgi bodies, vesicles, cell membrane and nuclear envelope. Members of the endomembrane system pass materials through each other or though the use of vesicles. +-------------------------------------- +GOID: GO:0016310 +Term: phosphorylation +Definition: The process of introducing a phosphate group into a molecule, usually with the formation of a phosphoric ester, a phosphoric anhydride or a phosphoric amide. +-------------------------------------- +GOID: GO:0016740 +Term: transferase activity +Definition: Catalysis of the transfer of a group, e.g. a methyl group, glycosyl group, acyl group, phosphorus-containing, or other groups, from one compound (generally regarded as the donor) to another compound (generally regarded as the acceptor). Transferase is the systematic name for any enzyme of EC class 2. +-------------------------------------- +GOID: GO:0031325 +Term: positive regulation of cellular metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways by which individual cells transform chemical substances. +-------------------------------------- +GOID: GO:0036211 +Term: protein modification process +Definition: The covalent alteration of one or more amino acids occurring in proteins, peptides and nascent polypeptides (co-translational, post-translational modifications). Includes the modification of charged tRNAs that are destined to occur in a protein (pre-translation modification). +-------------------------------------- +GOID: GO:0043169 +Term: cation binding +Definition: Interacting selectively and non-covalently with cations, charged atoms or groups of atoms with a net positive charge. +-------------------------------------- +GOID: GO:0044707 +Term: single-multicellular organism process +Definition: A biological process occurring within a single, multicellular organism. +-------------------------------------- +GOID: GO:0044711 +Term: single-organism biosynthetic process +Definition: A biosynthetic process - chemical reactions and pathways resulting in the formation of substances - involving a single organism. +-------------------------------------- +GOID: GO:0044712 +Term: single-organism catabolic process +Definition: A catabolic process - chemical reactions and pathways resulting in the breakdown of substances - which involves a single organism. +-------------------------------------- +GOID: GO:0048583 +Term: regulation of response to stimulus +Definition: Any process that modulates the frequency, rate or extent of a response to a stimulus. Response to stimulus is a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. +-------------------------------------- +GOID: GO:1901265 +Term: nucleoside phosphate binding +Definition: Interacting selectively and non-covalently with nucleoside phosphate. +-------------------------------------- +GOID: GO:1901575 +Term: organic substance catabolic process +Definition: The chemical reactions and pathways resulting in the breakdown of an organic substance, any molecular entity containing carbon. +-------------------------------------- +GOID: GO:0005215 +Term: transporter activity +Definition: Enables the directed movement of substances (such as macromolecules, small molecules, ions) into, out of or within a cell, or between cells. +-------------------------------------- +GOID: GO:0006950 +Term: response to stress +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a disturbance in organismal or cellular homeostasis, usually, but not necessarily, exogenous (e.g. temperature, humidity, ionizing radiation). +-------------------------------------- +GOID: GO:0006996 +Term: organelle organization +Definition: A process that is carried out at the cellular level which results in the assembly, arrangement of constituent parts, or disassembly of an organelle within a cell. An organelle is an organized structure of distinctive morphology and function. Includes the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0010033 +Term: response to organic substance +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an organic substance stimulus. +-------------------------------------- +GOID: GO:0016787 +Term: hydrolase activity +Definition: Catalysis of the hydrolysis of various bonds, e.g. C-O, C-N, C-C, phosphoric anhydride bonds, etc. Hydrolase is the systematic name for any enzyme of EC class 3. +-------------------------------------- +GOID: GO:0022892 +Term: substrate-specific transporter activity +Definition: Enables the directed movement of a specific substance or group of related substances (such as macromolecules, small molecules, ions) into, out of or within a cell, or between cells. +-------------------------------------- +GOID: GO:0032268 +Term: regulation of cellular protein metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving a protein, occurring at the level of an individual cell. +-------------------------------------- +GOID: GO:0033554 +Term: cellular response to stress +Definition: Any process that results in a change in state or activity of a cell (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus indicating the organism is under stress. The stress is usually, but not necessarily, exogenous (e.g. temperature, humidity, ionizing radiation). +-------------------------------------- +GOID: GO:0044282 +Term: small molecule catabolic process +Definition: The chemical reactions and pathways resulting in the breakdown of small molecules, any low molecular weight, monomeric, non-encoded molecule. +-------------------------------------- +GOID: GO:0044429 +Term: mitochondrial part +Definition: Any constituent part of a mitochondrion, a semiautonomous, self replicating organelle that occurs in varying numbers, shapes, and sizes in the cytoplasm of virtually all eukaryotic cells. It is notably the site of tissue respiration. +-------------------------------------- +GOID: GO:0046872 +Term: metal ion binding +Definition: Interacting selectively and non-covalently with any metal ion. +-------------------------------------- +GOID: GO:0051246 +Term: regulation of protein metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving a protein. +-------------------------------------- +GOID: GO:0055085 +Term: transmembrane transport +Definition: The process in which a solute is transported across a lipid bilayer, from one side of a membrane to the other +-------------------------------------- +GOID: GO:0070887 +Term: cellular response to chemical stimulus +Definition: Any process that results in a change in state or activity of a cell (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a chemical stimulus. +-------------------------------------- +GOID: GO:0090304 +Term: nucleic acid metabolic process +Definition: Any cellular metabolic process involving nucleic acids. +-------------------------------------- +GOID: GO:0005730 +Term: nucleolus +Definition: A small, dense body one or more of which are present in the nucleus of eukaryotic cells. It is rich in RNA and protein, is not bounded by a limiting membrane, and is not seen during mitosis. Its prime function is the transcription of the nucleolar DNA into 45S ribosomal-precursor RNA, the processing of this RNA into 5.8S, 18S, and 28S components of ribosomal RNA, and the association of these components with 5S RNA and proteins synthesized outside the nucleolus. This association results in the formation of ribonucleoprotein precursors; these pass into the cytoplasm and mature into the 40S and 60S subunits of the ribosome. +-------------------------------------- +GOID: GO:0006915 +Term: apoptotic process +Definition: A programmed cell death process which begins when a cell receives an internal (e.g. DNA damage) or external signal (e.g. an extracellular death ligand), and proceeds through a series of biochemical events (signaling pathway phase) which trigger an execution phase. The execution phase is the last step of an apoptotic process, and is typically characterized by rounding-up of the cell, retraction of pseudopodes, reduction of cellular volume (pyknosis), chromatin condensation, nuclear fragmentation (karyorrhexis), plasma membrane blebbing and fragmentation of the cell into apoptotic bodies. When the execution phase is completed, the cell has died. +-------------------------------------- +GOID: GO:0007166 +Term: cell surface receptor signaling pathway +Definition: A series of molecular signals initiated by activation of a receptor on the surface of a cell. The pathway begins with binding of an extracellular ligand to a cell surface receptor, or for receptors that signal in the absence of a ligand, by ligand-withdrawal or the activity of a constitutively active receptor. The pathway ends with regulation of a downstream cellular process, e.g. transcription. +-------------------------------------- +GOID: GO:0007275 +Term: multicellular organism development +Definition: The biological process whose specific outcome is the progression of a multicellular organism over time from an initial condition (e.g. a zygote or a young adult) to a later condition (e.g. a multicellular animal or an aged adult). +-------------------------------------- +GOID: GO:0008219 +Term: cell death +Definition: Any biological process that results in permanent cessation of all vital functions of a cell. A cell should be considered dead when any one of the following molecular or morphological criteria is met: (1) the cell has lost the integrity of its plasma membrane; (2) the cell, including its nucleus, has undergone complete fragmentation into discrete bodies (frequently referred to as apoptotic bodies). The cell corpse (or its fragments) may be engulfed by an adjacent cell in vivo, but engulfment of whole cells should not be considered a strict criteria to define cell death as, under some circumstances, live engulfed cells can be released from phagosomes (see PMID:18045538). +-------------------------------------- +GOID: GO:0008283 +Term: cell proliferation +Definition: The multiplication or reproduction of cells, resulting in the expansion of a cell population. +-------------------------------------- +GOID: GO:0008289 +Term: lipid binding +Definition: Interacting selectively and non-covalently with a lipid. +-------------------------------------- +GOID: GO:0008610 +Term: lipid biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of lipids, compounds soluble in an organic solvent but not, or sparingly, in an aqueous solvent. +-------------------------------------- +GOID: GO:0009719 +Term: response to endogenous stimulus +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus arising within the organism. +-------------------------------------- +GOID: GO:0009966 +Term: regulation of signal transduction +Definition: Any process that modulates the frequency, rate or extent of signal transduction. +-------------------------------------- +GOID: GO:0010604 +Term: positive regulation of macromolecule metabolic process +Definition: Any process that increases the frequency, rate or extent of the chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0010646 +Term: regulation of cell communication +Definition: Any process that modulates the frequency, rate or extent of cell communication. Cell communication is the process that mediates interactions between a cell and its surroundings. Encompasses interactions such as signaling or attachment between one cell and another cell, between a cell and an extracellular matrix, or between a cell and any other aspect of its environment. +-------------------------------------- +GOID: GO:0012501 +Term: programmed cell death +Definition: A process which begins when a cell receives an internal or external signal and activates a series of biochemical events (signaling pathway). The process ends with the death of the cell. +-------------------------------------- +GOID: GO:0019637 +Term: organophosphate metabolic process +Definition: The chemical reactions and pathways involving organophosphates, any phosphate-containing organic compound. +-------------------------------------- +GOID: GO:0022857 +Term: transmembrane transporter activity +Definition: Enables the transfer of a substance from one side of a membrane to the other. +-------------------------------------- +GOID: GO:0023051 +Term: regulation of signaling +Definition: Any process that modulates the frequency, rate or extent of a signaling process. +-------------------------------------- +GOID: GO:0030258 +Term: lipid modification +Definition: The covalent alteration of one or more fatty acids in a lipid, resulting in a change in the properties of the lipid. +-------------------------------------- +GOID: GO:0032502 +Term: developmental process +Definition: A biological process whose specific outcome is the progression of an integrated living unit: an anatomical structure (which may be a subcellular structure, cell, tissue, or organ), or organism over time from an initial condition to a later condition. +-------------------------------------- +GOID: GO:0044248 +Term: cellular catabolic process +Definition: The chemical reactions and pathways resulting in the breakdown of substances, carried out by individual cells. +-------------------------------------- +GOID: GO:0044765 +Term: single-organism transport +Definition: The directed movement of substances (such as macromolecules, small molecules, ions) into, out of or within a cell, or between cells, or within a multicellular organism by means of some agent such as a transporter or pore, involving a single organism. +-------------------------------------- +GOID: GO:0044767 +Term: single-organism developmental process +Definition: A biological process whose specific outcome is the progression of an integrated living unit: an anatomical structure (which may be a subcellular structure, cell, tissue, or organ), or organism over time from an initial condition to a later condition, involving only one organism. +-------------------------------------- +GOID: GO:0046914 +Term: transition metal ion binding +Definition: Interacting selectively and non-covalently with a transition metal ions; a transition metal is an element whose atom has an incomplete d-subshell of extranuclear electrons, or which gives rise to a cation or cations with an incomplete d-subshell. Transition metals often have more than one valency state. Biologically relevant transition metals include vanadium, manganese, iron, copper, cobalt, nickel, molybdenum and silver. +-------------------------------------- +GOID: GO:0046983 +Term: protein dimerization activity +Definition: The formation of a protein dimer, a macromolecular structure consists of two noncovalently associated identical or nonidentical subunits. +-------------------------------------- +GOID: GO:0048519 +Term: negative regulation of biological process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of a biological process. Biological processes are regulated by many means; examples include the control of gene expression, protein modification or interaction with a protein or substrate molecule. +-------------------------------------- +GOID: GO:0048523 +Term: negative regulation of cellular process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of a cellular process, any of those that are carried out at the cellular level, but are not necessarily restricted to a single cell. For example, cell communication occurs among more than one cell, but occurs at the cellular level. +-------------------------------------- +GOID: GO:0048856 +Term: anatomical structure development +Definition: The biological process whose specific outcome is the progression of an anatomical structure from an initial condition to its mature state. This process begins with the formation of the structure and ends with the mature structure, whatever form that may be including its natural destruction. An anatomical structure is any biological entity that occupies space and is distinguished from its surroundings. Anatomical structures can be macroscopic such as a carpel, or microscopic such as an acrosome. +-------------------------------------- +GOID: GO:0055086 +Term: nucleobase-containing small molecule metabolic process +Definition: The cellular chemical reactions and pathways involving a nucleobase-containing small molecule: a nucleobase, a nucleoside, or a nucleotide. +-------------------------------------- +GOID: GO:0065009 +Term: regulation of molecular function +Definition: Any process that modulates the frequency, rate or extent of a molecular function, an elemental biological activity occurring at the molecular level, such as catalysis or binding. +-------------------------------------- +GOID: GO:0071702 +Term: organic substance transport +Definition: The directed movement of organic substances into, out of or within a cell, or between cells, or within a multicellular organism by means of some agent such as a transporter or pore. An organic substance is a molecular entity that contains carbon. +-------------------------------------- +GOID: GO:1902578 +Term: single-organism localization +Definition: A localization which involves only one organism. +-------------------------------------- + +-------------------------------------- +cluster: 3 +-------------------------------------- + +-------------------------------------- +GOID: GO:0005575 +Term: cellular_component +Definition: The part of a cell or its extracellular environment in which a gene product is located. A gene product may be located in one or more parts of a cell and its location may be as specific as a particular macromolecular complex, that is, a stable, persistent association of macromolecules that function together. +-------------------------------------- +GOID: GO:0008150 +Term: biological_process +Definition: Any process specifically pertinent to the functioning of integrated living units: cells, tissues, organs, and organisms. A process is a collection of molecular events with a defined beginning and end. +-------------------------------------- +GOID: GO:0003674 +Term: molecular_function +Definition: Elemental activities, such as catalysis or binding, describing the actions of a gene product at the molecular level. A given gene product may exhibit one or more molecular functions. +-------------------------------------- +GOID: GO:0005623 +Term: cell +Definition: The basic structural and functional unit of all organisms. Includes the plasma membrane and any external encapsulating structures such as the cell wall and cell envelope. +-------------------------------------- +GOID: GO:0044464 +Term: cell part +Definition: Any constituent part of a cell, the basic structural and functional unit of all organisms. +-------------------------------------- +GOID: GO:0009987 +Term: cellular process +Definition: Any process that is carried out at the cellular level, but not necessarily restricted to a single cell. For example, cell communication occurs among more than one cell, but occurs at the cellular level. +-------------------------------------- +GOID: GO:0044699 +Term: single-organism process +Definition: A biological process that involves only one organism. +-------------------------------------- +GOID: GO:0005488 +Term: binding +Definition: The selective, non-covalent, often stoichiometric, interaction of a molecule with one or more specific sites on another molecule. +-------------------------------------- +GOID: GO:0043226 +Term: organelle +Definition: Organized structure of distinctive morphology and function. Includes the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton, and prokaryotic structures such as anammoxosomes and pirellulosomes. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0065007 +Term: biological regulation +Definition: Any process that modulates a measurable attribute of any biological process, quality or function. +-------------------------------------- +GOID: GO:0043227 +Term: membrane-bounded organelle +Definition: Organized structure of distinctive morphology and function, bounded by a single or double lipid bilayer membrane. Includes the nucleus, mitochondria, plastids, vacuoles, and vesicles. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0050789 +Term: regulation of biological process +Definition: Any process that modulates the frequency, rate or extent of a biological process. Biological processes are regulated by many means; examples include the control of gene expression, protein modification or interaction with a protein or substrate molecule. +-------------------------------------- +GOID: GO:0005622 +Term: intracellular +Definition: The living contents of a cell; the matter contained within (but not including) the plasma membrane, usually taken to exclude large vacuoles and masses of secretory or ingested material. In eukaryotes it includes the nucleus and cytoplasm. +-------------------------------------- +GOID: GO:0008152 +Term: metabolic process +Definition: The chemical reactions and pathways, including anabolism and catabolism, by which living organisms transform chemical substances. Metabolic processes typically transform small molecules, but also include macromolecular processes such as DNA repair and replication, and protein synthesis and degradation. +-------------------------------------- +GOID: GO:0044424 +Term: intracellular part +Definition: Any constituent part of the living contents of a cell; the matter contained within (but not including) the plasma membrane, usually taken to exclude large vacuoles and masses of secretory or ingested material. In eukaryotes it includes the nucleus and cytoplasm. +-------------------------------------- +GOID: GO:0071704 +Term: organic substance metabolic process +Definition: The chemical reactions and pathways involving an organic substance, any molecular entity containing carbon. +-------------------------------------- +GOID: GO:0016020 +Term: membrane +Definition: A lipid bilayer along with all the proteins and protein complexes embedded in it an attached to it. +-------------------------------------- +GOID: GO:0050794 +Term: regulation of cellular process +Definition: Any process that modulates the frequency, rate or extent of a cellular process, any of those that are carried out at the cellular level, but are not necessarily restricted to a single cell. For example, cell communication occurs among more than one cell, but occurs at the cellular level. +-------------------------------------- +GOID: GO:0044238 +Term: primary metabolic process +Definition: The chemical reactions and pathways involving those compounds which are formed as a part of the normal anabolic and catabolic processes. These processes take place in most, if not all, cells of the organism. +-------------------------------------- +GOID: GO:0050896 +Term: response to stimulus +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. The process begins with detection of the stimulus and ends with a change in state or activity or the cell or organism. +-------------------------------------- +GOID: GO:0043170 +Term: macromolecule metabolic process +Definition: The chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0044763 +Term: single-organism cellular process +Definition: Any process that is carried out at the cellular level, occurring within a single organism. +-------------------------------------- +GOID: GO:0043229 +Term: intracellular organelle +Definition: Organized structure of distinctive morphology and function, occurring within the cell. Includes the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0043231 +Term: intracellular membrane-bounded organelle +Definition: Organized structure of distinctive morphology and function, bounded by a single or double lipid bilayer membrane and occurring within the cell. Includes the nucleus, mitochondria, plastids, vacuoles, and vesicles. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0005515 +Term: protein binding +Definition: Interacting selectively and non-covalently with any protein or protein complex (a complex of two or more proteins that may include other nonprotein molecules). +-------------------------------------- +GOID: GO:0005737 +Term: cytoplasm +Definition: All of the contents of a cell excluding the plasma membrane and nucleus, but including other subcellular structures. +-------------------------------------- +GOID: GO:0005576 +Term: extracellular region +Definition: The space external to the outermost structure of a cell. For cells without external protective or external encapsulating structures this refers to space outside of the plasma membrane. This term covers the host cell environment outside an intracellular parasite. +-------------------------------------- +GOID: GO:0044237 +Term: cellular metabolic process +Definition: The chemical reactions and pathways by which individual cells transform chemical substances. +-------------------------------------- +GOID: GO:0044421 +Term: extracellular region part +Definition: Any constituent part of the extracellular region, the space external to the outermost structure of a cell. For cells without external protective or external encapsulating structures this refers to space outside of the plasma membrane. This term covers constituent parts of the host cell environment outside an intracellular parasite. +-------------------------------------- +GOID: GO:0032501 +Term: multicellular organismal process +Definition: Any biological process, occurring at the level of a multicellular organism, pertinent to its function. +-------------------------------------- +GOID: GO:0044425 +Term: membrane part +Definition: Any constituent part of a membrane, a double layer of lipid molecules that encloses all cells, and, in eukaryotes, many organelles; may be a single or double lipid bilayer; also includes associated proteins. +-------------------------------------- +GOID: GO:0048518 +Term: positive regulation of biological process +Definition: Any process that activates or increases the frequency, rate or extent of a biological process. Biological processes are regulated by many means; examples include the control of gene expression, protein modification or interaction with a protein or substrate molecule. +-------------------------------------- +GOID: GO:0051179 +Term: localization +Definition: Any process in which a cell, a substance, or a cellular entity, such as a protein complex or organelle, is transported, tethered to or otherwise maintained in a specific location. In the case of substances, localization may also be achieved via selective degradation. +-------------------------------------- +GOID: GO:0044260 +Term: cellular macromolecule metabolic process +Definition: The chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass, as carried out by individual cells. +-------------------------------------- +GOID: GO:0044444 +Term: cytoplasmic part +Definition: Any constituent part of the cytoplasm, all of the contents of a cell excluding the plasma membrane and nucleus, but including other subcellular structures. +-------------------------------------- +GOID: GO:0044707 +Term: single-multicellular organism process +Definition: A biological process occurring within a single, multicellular organism. +-------------------------------------- +GOID: GO:0016021 +Term: integral component of membrane +Definition: The component of a membrane consisting of the gene products and protein complexes having at least some part of their peptide sequence embedded in the hydrophobic region of the membrane. +-------------------------------------- +GOID: GO:0019538 +Term: protein metabolic process +Definition: The chemical reactions and pathways involving a specific protein, rather than of proteins in general. Includes protein modification. +-------------------------------------- +GOID: GO:0031224 +Term: intrinsic component of membrane +Definition: The component of a membrane consisting of the gene products having some covalently attached portion, for example part of a peptide sequence or some other covalently attached group such as a GPI anchor, which spans or is embedded in one or both leaflets of the membrane. +-------------------------------------- +GOID: GO:0031982 +Term: vesicle +Definition: Any small, fluid-filled, spherical organelle enclosed by membrane. +-------------------------------------- +GOID: GO:0006950 +Term: response to stress +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a disturbance in organismal or cellular homeostasis, usually, but not necessarily, exogenous (e.g. temperature, humidity, ionizing radiation). +-------------------------------------- +GOID: GO:0019222 +Term: regulation of metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways within a cell or an organism. +-------------------------------------- +GOID: GO:0048583 +Term: regulation of response to stimulus +Definition: Any process that modulates the frequency, rate or extent of a response to a stimulus. Response to stimulus is a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. +-------------------------------------- +GOID: GO:0002376 +Term: immune system process +Definition: Any process involved in the development or functioning of the immune system, an organismal system for calibrated responses to potential internal or invasive threats. +-------------------------------------- +GOID: GO:0005615 +Term: extracellular space +Definition: That part of a multicellular organism outside the cells proper, usually taken to be outside the plasma membranes, and occupied by fluid. +-------------------------------------- +GOID: GO:0051716 +Term: cellular response to stimulus +Definition: Any process that results in a change in state or activity of a cell (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. The process begins with detection of the stimulus by a cell and ends with a change in state or activity or the cell. +-------------------------------------- +GOID: GO:0071944 +Term: cell periphery +Definition: The part of a cell encompassing the cell cortex, the plasma membrane, and any external encapsulating structures. +-------------------------------------- +GOID: GO:0003824 +Term: catalytic activity +Definition: Catalysis of a biochemical reaction at physiological temperatures. In biologically catalyzed reactions, the reactants are known as substrates, and the catalysts are naturally occurring macromolecular substances known as enzymes. Enzymes possess specific binding sites for substrates, and are usually composed wholly or largely of protein, but RNA that has catalytic activity (ribozyme) is often also regarded as enzymatic. +-------------------------------------- +GOID: GO:0005886 +Term: plasma membrane +Definition: The membrane surrounding a cell that separates the cell from its external environment. It consists of a phospholipid bilayer and associated proteins. +-------------------------------------- +GOID: GO:0031988 +Term: membrane-bounded vesicle +Definition: Any small, fluid-filled, spherical organelle enclosed by a lipid bilayer. +-------------------------------------- +GOID: GO:0060255 +Term: regulation of macromolecule metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0031323 +Term: regulation of cellular metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways by which individual cells transform chemical substances. +-------------------------------------- +GOID: GO:0048522 +Term: positive regulation of cellular process +Definition: Any process that activates or increases the frequency, rate or extent of a cellular process, any of those that are carried out at the cellular level, but are not necessarily restricted to a single cell. For example, cell communication occurs among more than one cell, but occurs at the cellular level. +-------------------------------------- +GOID: GO:0080090 +Term: regulation of primary metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways within a cell or an organism involving those compounds formed as a part of the normal anabolic and catabolic processes. These processes take place in most, if not all, cells of the organism. +-------------------------------------- +GOID: GO:0043167 +Term: ion binding +Definition: Interacting selectively and non-covalently with ions, charged atoms or groups of atoms. +-------------------------------------- +GOID: GO:0043230 +Term: extracellular organelle +Definition: Organized structure of distinctive morphology and function, occurring outside the cell. Includes, for example, extracellular membrane vesicles (EMVs) and the cellulosomes of anaerobic bacteria and fungi. +-------------------------------------- +GOID: GO:0048519 +Term: negative regulation of biological process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of a biological process. Biological processes are regulated by many means; examples include the control of gene expression, protein modification or interaction with a protein or substrate molecule. +-------------------------------------- +GOID: GO:0070062 +Term: extracellular exosome +Definition: A membrane-bounded vesicle that is released into the extracellular region by fusion of the limiting endosomal membrane of a multivesicular body with the plasma membrane. Extracellular exosomes, also simply called exosomes, have a diameter of about 40-100 nm. +-------------------------------------- +GOID: GO:1903561 +Term: extracellular vesicle +Definition: Any vesicle that is part of the extracellular region. +-------------------------------------- +GOID: GO:0043169 +Term: cation binding +Definition: Interacting selectively and non-covalently with cations, charged atoms or groups of atoms with a net positive charge. +-------------------------------------- +GOID: GO:0046872 +Term: metal ion binding +Definition: Interacting selectively and non-covalently with any metal ion. +-------------------------------------- +GOID: GO:0007275 +Term: multicellular organism development +Definition: The biological process whose specific outcome is the progression of a multicellular organism over time from an initial condition (e.g. a zygote or a young adult) to a later condition (e.g. a multicellular animal or an aged adult). +-------------------------------------- +GOID: GO:0012505 +Term: endomembrane system +Definition: A collection of membranous structures involved in transport within the cell. The main components of the endomembrane system are endoplasmic reticulum, Golgi bodies, vesicles, cell membrane and nuclear envelope. Members of the endomembrane system pass materials through each other or though the use of vesicles. +-------------------------------------- +GOID: GO:0032502 +Term: developmental process +Definition: A biological process whose specific outcome is the progression of an integrated living unit: an anatomical structure (which may be a subcellular structure, cell, tissue, or organ), or organism over time from an initial condition to a later condition. +-------------------------------------- +GOID: GO:0044767 +Term: single-organism developmental process +Definition: A biological process whose specific outcome is the progression of an integrated living unit: an anatomical structure (which may be a subcellular structure, cell, tissue, or organ), or organism over time from an initial condition to a later condition, involving only one organism. +-------------------------------------- +GOID: GO:0048856 +Term: anatomical structure development +Definition: The biological process whose specific outcome is the progression of an anatomical structure from an initial condition to its mature state. This process begins with the formation of the structure and ends with the mature structure, whatever form that may be including its natural destruction. An anatomical structure is any biological entity that occupies space and is distinguished from its surroundings. Anatomical structures can be macroscopic such as a carpel, or microscopic such as an acrosome. +-------------------------------------- +GOID: GO:0051234 +Term: establishment of localization +Definition: Any process that localizes a substance or cellular component. This may occur via movement, tethering or selective degradation. +-------------------------------------- +GOID: GO:0006810 +Term: transport +Definition: The directed movement of substances (such as macromolecules, small molecules, ions) or cellular components (such as complexes and organelles) into, out of or within a cell, or between cells, or within a multicellular organism by means of some agent such as a transporter, pore or motor protein. +-------------------------------------- +GOID: GO:0007154 +Term: cell communication +Definition: Any process that mediates interactions between a cell and its surroundings. Encompasses interactions such as signaling or attachment between one cell and another cell, between a cell and an extracellular matrix, or between a cell and any other aspect of its environment. +-------------------------------------- +GOID: GO:0023052 +Term: signaling +Definition: The entirety of a process in which information is transmitted within a biological system. This process begins with an active signal and ends when a cellular response has been triggered. +-------------------------------------- +GOID: GO:0044700 +Term: single organism signaling +Definition: A signaling process occurring within a single organism. +-------------------------------------- +GOID: GO:0009058 +Term: biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of substances; typically the energy-requiring part of metabolism in which simpler substances are transformed into more complex ones. +-------------------------------------- +GOID: GO:0044249 +Term: cellular biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of substances, carried out by individual cells. +-------------------------------------- +GOID: GO:0048523 +Term: negative regulation of cellular process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of a cellular process, any of those that are carried out at the cellular level, but are not necessarily restricted to a single cell. For example, cell communication occurs among more than one cell, but occurs at the cellular level. +-------------------------------------- +GOID: GO:0071840 +Term: cellular component organization or biogenesis +Definition: A process that results in the biosynthesis of constituent macromolecules, assembly, arrangement of constituent parts, or disassembly of a cellular component. +-------------------------------------- +GOID: GO:1901576 +Term: organic substance biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of an organic substance, any molecular entity containing carbon. +-------------------------------------- +GOID: GO:0005634 +Term: nucleus +Definition: A membrane-bounded organelle of eukaryotic cells in which chromosomes are housed and replicated. In most cells, the nucleus contains all of the cell's chromosomes except the organellar chromosomes, and is the site of RNA synthesis and processing. In some species, or in specialized cell types, RNA metabolism or DNA replication may be absent. +-------------------------------------- +GOID: GO:0006807 +Term: nitrogen compound metabolic process +Definition: The chemical reactions and pathways involving organic or inorganic compounds that contain nitrogen, including (but not limited to) nitrogen fixation, nitrification, denitrification, assimilatory/dissimilatory nitrate reduction and the interconversion of nitrogenous organic matter and ammonium. +-------------------------------------- +GOID: GO:0007165 +Term: signal transduction +Definition: The cellular process in which a signal is conveyed to trigger a change in the activity or state of a cell. Signal transduction begins with reception of a signal (e.g. a ligand binding to a receptor or receptor activation by a stimulus such as light), or for signal transduction in the absence of ligand, signal-withdrawal or the activity of a constitutively active receptor. Signal transduction ends with regulation of a downstream cellular process, e.g. regulation of transcription or regulation of a metabolic process. Signal transduction covers signaling from receptors located on the surface of the cell and signaling via molecules located within the cell. For signaling between cells, signal transduction is restricted to events at and within the receiving cell. +-------------------------------------- +GOID: GO:0009605 +Term: response to external stimulus +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an external stimulus. +-------------------------------------- +GOID: GO:0016043 +Term: cellular component organization +Definition: A process that results in the assembly, arrangement of constituent parts, or disassembly of a cellular component. +-------------------------------------- +GOID: GO:0048731 +Term: system development +Definition: The process whose specific outcome is the progression of an organismal system over time, from its formation to the mature structure. A system is a regularly interacting or interdependent group of organs or tissues that work together to carry out a given biological process. +-------------------------------------- +GOID: GO:0010467 +Term: gene expression +Definition: The process in which a gene's sequence is converted into a mature gene product or products (proteins or RNA). This includes the production of an RNA transcript as well as any processing to produce a mature RNA product or an mRNA (for protein-coding genes) and the translation of that mRNA into protein. Protein maturation is included when required to form an active form of a product from an inactive precursor form. +-------------------------------------- +GOID: GO:0006952 +Term: defense response +Definition: Reactions, triggered in response to the presence of a foreign body or the occurrence of an injury, which result in restriction of damage to the organism attacked or prevention/recovery from the infection caused by the attack. +-------------------------------------- +GOID: GO:0009059 +Term: macromolecule biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of a macromolecule, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0034641 +Term: cellular nitrogen compound metabolic process +Definition: The chemical reactions and pathways involving various organic and inorganic nitrogenous compounds, as carried out by individual cells. +-------------------------------------- +GOID: GO:0051239 +Term: regulation of multicellular organismal process +Definition: Any process that modulates the frequency, rate or extent of a multicellular organismal process, the processes pertinent to the function of a multicellular organism above the cellular level; includes the integrated processes of tissues and organs. +-------------------------------------- +GOID: GO:0065008 +Term: regulation of biological quality +Definition: Any process that modulates a qualitative or quantitative trait of a biological quality. A biological quality is a measurable attribute of an organism or part of an organism, such as size, mass, shape, color, etc. +-------------------------------------- +GOID: GO:1901360 +Term: organic cyclic compound metabolic process +Definition: The chemical reactions and pathways involving organic cyclic compound. +-------------------------------------- +GOID: GO:0006955 +Term: immune response +Definition: Any immune system process that functions in the calibrated response of an organism to a potential internal or invasive threat. +-------------------------------------- +GOID: GO:0042221 +Term: response to chemical +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a chemical stimulus. +-------------------------------------- +GOID: GO:0044267 +Term: cellular protein metabolic process +Definition: The chemical reactions and pathways involving a specific protein, rather than of proteins in general, occurring at the level of an individual cell. Includes cellular protein modification. +-------------------------------------- +GOID: GO:0044422 +Term: organelle part +Definition: Any constituent part of an organelle, an organized structure of distinctive morphology and function. Includes constituent parts of the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton, but excludes the plasma membrane. +-------------------------------------- +GOID: GO:0044446 +Term: intracellular organelle part +Definition: A constituent part of an intracellular organelle, an organized structure of distinctive morphology and function, occurring within the cell. Includes constituent parts of the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton but excludes the plasma membrane. +-------------------------------------- +GOID: GO:0048584 +Term: positive regulation of response to stimulus +Definition: Any process that activates, maintains or increases the rate of a response to a stimulus. Response to stimulus is a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. +-------------------------------------- +GOID: GO:0002682 +Term: regulation of immune system process +Definition: Any process that modulates the frequency, rate, or extent of an immune system process. +-------------------------------------- +GOID: GO:0032879 +Term: regulation of localization +Definition: Any process that modulates the frequency, rate or extent of any process in which a cell, a substance, or a cellular entity is transported to, or maintained in, a specific location. +-------------------------------------- +GOID: GO:0034645 +Term: cellular macromolecule biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of a macromolecule, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass, carried out by individual cells. +-------------------------------------- +GOID: GO:0048513 +Term: animal organ development +Definition: Development of a tissue or tissues that work together to perform a specific function or functions. Development pertains to the process whose specific outcome is the progression of a structure over time, from its formation to the mature structure. Organs are commonly observed as visibly distinct structures, but may also exist as loosely associated clusters of cells that work together to perform a specific function or functions. +-------------------------------------- +GOID: GO:0097159 +Term: organic cyclic compound binding +Definition: Interacting selectively and non-covalently with an organic cyclic compound, any molecular entity that contains carbon arranged in a cyclic molecular structure. +-------------------------------------- +GOID: GO:1901363 +Term: heterocyclic compound binding +Definition: Interacting selectively and non-covalently with heterocyclic compound. +-------------------------------------- +GOID: GO:0006139 +Term: nucleobase-containing compound metabolic process +Definition: Any cellular metabolic process involving nucleobases, nucleosides, nucleotides and nucleic acids. +-------------------------------------- +GOID: GO:0006508 +Term: proteolysis +Definition: The hydrolysis of proteins into smaller polypeptides and/or amino acids by cleavage of their peptide bonds. +-------------------------------------- +GOID: GO:0006725 +Term: cellular aromatic compound metabolic process +Definition: The chemical reactions and pathways involving aromatic compounds, any organic compound characterized by one or more planar rings, each of which contains conjugated double bonds and delocalized pi electrons, as carried out by individual cells. +-------------------------------------- +GOID: GO:0030154 +Term: cell differentiation +Definition: The process in which relatively unspecialized cells, e.g. embryonic or regenerative cells, acquire specialized structural and/or functional features that characterize the cells, tissues, or organs of the mature organism or some other relatively stable phase of the organism's life history. Differentiation includes the processes involved in commitment of a cell to a specific fate and its subsequent development to the mature state. +-------------------------------------- +GOID: GO:0032991 +Term: macromolecular complex +Definition: A stable assembly of two or more macromolecules, i.e. proteins, nucleic acids, carbohydrates or lipids, in which the constituent parts function together. +-------------------------------------- +GOID: GO:0046483 +Term: heterocycle metabolic process +Definition: The chemical reactions and pathways involving heterocyclic compounds, those with a cyclic molecular structure and at least two different atoms in the ring (or rings). +-------------------------------------- +GOID: GO:0048869 +Term: cellular developmental process +Definition: A biological process whose specific outcome is the progression of a cell over time from an initial condition to a later condition. +-------------------------------------- +GOID: GO:0010468 +Term: regulation of gene expression +Definition: Any process that modulates the frequency, rate or extent of gene expression. Gene expression is the process in which a gene's coding sequence is converted into a mature gene product or products (proteins or RNA). This includes the production of an RNA transcript as well as any processing to produce a mature RNA product or an mRNA (for protein-coding genes) and the translation of that mRNA into protein. Protein maturation is included when required to form an active form of a product from an inactive precursor form. +-------------------------------------- +GOID: GO:0044271 +Term: cellular nitrogen compound biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of organic and inorganic nitrogenous compounds. +-------------------------------------- +GOID: GO:0044459 +Term: plasma membrane part +Definition: Any constituent part of the plasma membrane, the membrane surrounding a cell that separates the cell from its external environment. It consists of a phospholipid bilayer and associated proteins. +-------------------------------------- +GOID: GO:0044710 +Term: single-organism metabolic process +Definition: A metabolic process - chemical reactions and pathways, including anabolism and catabolism, by which living organisms transform chemical substances - which involves a single organism. +-------------------------------------- +GOID: GO:0090304 +Term: nucleic acid metabolic process +Definition: Any cellular metabolic process involving nucleic acids. +-------------------------------------- +GOID: GO:0050793 +Term: regulation of developmental process +Definition: Any process that modulates the frequency, rate or extent of development, the biological process whose specific outcome is the progression of a multicellular organism over time from an initial condition (e.g. a zygote, or a young adult) to a later condition (e.g. a multicellular animal or an aged adult). +-------------------------------------- +GOID: GO:0051246 +Term: regulation of protein metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving a protein. +-------------------------------------- +GOID: GO:0005783 +Term: endoplasmic reticulum +Definition: The irregular network of unit membranes, visible only by electron microscopy, that occurs in the cytoplasm of many eukaryotic cells. The membranes form a complex meshwork of tubular channels, which are often expanded into slitlike cavities called cisternae. The ER takes two forms, rough (or granular), with ribosomes adhering to the outer surface, and smooth (with no ribosomes attached). +-------------------------------------- +GOID: GO:0007166 +Term: cell surface receptor signaling pathway +Definition: A series of molecular signals initiated by activation of a receptor on the surface of a cell. The pathway begins with binding of an extracellular ligand to a cell surface receptor, or for receptors that signal in the absence of a ligand, by ligand-withdrawal or the activity of a constitutively active receptor. The pathway ends with regulation of a downstream cellular process, e.g. transcription. +-------------------------------------- +GOID: GO:0009889 +Term: regulation of biosynthetic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways resulting in the formation of substances. +-------------------------------------- +GOID: GO:0009893 +Term: positive regulation of metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways within a cell or an organism. +-------------------------------------- +GOID: GO:0016070 +Term: RNA metabolic process +Definition: The cellular chemical reactions and pathways involving RNA, ribonucleic acid, one of the two main type of nucleic acid, consisting of a long, unbranched macromolecule formed from ribonucleotides joined in 3',5'-phosphodiester linkage. +-------------------------------------- +GOID: GO:0016787 +Term: hydrolase activity +Definition: Catalysis of the hydrolysis of various bonds, e.g. C-O, C-N, C-C, phosphoric anhydride bonds, etc. Hydrolase is the systematic name for any enzyme of EC class 3. +-------------------------------------- +GOID: GO:0031326 +Term: regulation of cellular biosynthetic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways resulting in the formation of substances, carried out by individual cells. +-------------------------------------- +GOID: GO:0043234 +Term: protein complex +Definition: A stable macromolecular complex composed (only) of two or more polypeptide subunits along with any covalently attached molecules (such as lipid anchors or oligosaccharide) or non-protein prosthetic groups (such as nucleotides or metal ions). Prosthetic group in this context refers to a tightly bound cofactor. The component polypeptide subunits may be identical. +-------------------------------------- +GOID: GO:1901362 +Term: organic cyclic compound biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of organic cyclic compound. +-------------------------------------- +GOID: GO:0006928 +Term: movement of cell or subcellular component +Definition: The directed, self-propelled movement of a cell or subcellular component without the involvement of an external agent such as a transporter or a pore. +-------------------------------------- +GOID: GO:0010556 +Term: regulation of macromolecule biosynthetic process +Definition: Any process that modulates the rate, frequency or extent of the chemical reactions and pathways resulting in the formation of a macromolecule, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0010604 +Term: positive regulation of macromolecule metabolic process +Definition: Any process that increases the frequency, rate or extent of the chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0010646 +Term: regulation of cell communication +Definition: Any process that modulates the frequency, rate or extent of cell communication. Cell communication is the process that mediates interactions between a cell and its surroundings. Encompasses interactions such as signaling or attachment between one cell and another cell, between a cell and an extracellular matrix, or between a cell and any other aspect of its environment. +-------------------------------------- +GOID: GO:0016477 +Term: cell migration +Definition: The controlled self-propelled movement of a cell from one site to a destination guided by molecular cues. Cell migration is a central process in the development and maintenance of multicellular organisms. +-------------------------------------- +GOID: GO:0018130 +Term: heterocycle biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of heterocyclic compounds, those with a cyclic molecular structure and at least two different atoms in the ring (or rings). +-------------------------------------- +GOID: GO:0019219 +Term: regulation of nucleobase-containing compound metabolic process +Definition: Any cellular process that modulates the frequency, rate or extent of the chemical reactions and pathways involving nucleobases, nucleosides, nucleotides and nucleic acids. +-------------------------------------- +GOID: GO:0019438 +Term: aromatic compound biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of aromatic compounds, any substance containing an aromatic carbon ring. +-------------------------------------- +GOID: GO:0023051 +Term: regulation of signaling +Definition: Any process that modulates the frequency, rate or extent of a signaling process. +-------------------------------------- +GOID: GO:0031325 +Term: positive regulation of cellular metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways by which individual cells transform chemical substances. +-------------------------------------- +GOID: GO:0032101 +Term: regulation of response to external stimulus +Definition: Any process that modulates the frequency, rate or extent of a response to an external stimulus. +-------------------------------------- +GOID: GO:0034654 +Term: nucleobase-containing compound biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of nucleobases, nucleosides, nucleotides and nucleic acids. +-------------------------------------- +GOID: GO:0040011 +Term: locomotion +Definition: Self-propelled movement of a cell or organism from one location to another. +-------------------------------------- +GOID: GO:0044765 +Term: single-organism transport +Definition: The directed movement of substances (such as macromolecules, small molecules, ions) into, out of or within a cell, or between cells, or within a multicellular organism by means of some agent such as a transporter or pore, involving a single organism. +-------------------------------------- +GOID: GO:0048870 +Term: cell motility +Definition: Any process involved in the controlled self-propelled movement of a cell that results in translocation of the cell from one place to another. +-------------------------------------- +GOID: GO:0051171 +Term: regulation of nitrogen compound metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving nitrogen or nitrogenous compounds. +-------------------------------------- +GOID: GO:0051674 +Term: localization of cell +Definition: Any process in which a cell is transported to, and/or maintained in, a specific location. +-------------------------------------- +GOID: GO:0080134 +Term: regulation of response to stress +Definition: Any process that modulates the frequency, rate or extent of a response to stress. Response to stress is a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a disturbance in organismal or cellular homeostasis, usually, but not necessarily, exogenous (e.g. temperature, humidity, ionizing radiation). +-------------------------------------- +GOID: GO:1902578 +Term: single-organism localization +Definition: A localization which involves only one organism. +-------------------------------------- +GOID: GO:0006351 +Term: transcription, DNA-templated +Definition: The cellular synthesis of RNA on a template of DNA. +-------------------------------------- +GOID: GO:0009892 +Term: negative regulation of metabolic process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of the chemical reactions and pathways within a cell or an organism. +-------------------------------------- +GOID: GO:0009966 +Term: regulation of signal transduction +Definition: Any process that modulates the frequency, rate or extent of signal transduction. +-------------------------------------- +GOID: GO:0010605 +Term: negative regulation of macromolecule metabolic process +Definition: Any process that decreases the frequency, rate or extent of the chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0031324 +Term: negative regulation of cellular metabolic process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of the chemical reactions and pathways by which individual cells transform chemical substances. +-------------------------------------- +GOID: GO:0032268 +Term: regulation of cellular protein metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving a protein, occurring at the level of an individual cell. +-------------------------------------- +GOID: GO:0032774 +Term: RNA biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of RNA, ribonucleic acid, one of the two main type of nucleic acid, consisting of a long, unbranched macromolecule formed from ribonucleotides joined in 3',5'-phosphodiester linkage. Includes polymerization of ribonucleotide monomers. Refers not only to transcription but also to e.g. viral RNA replication. +-------------------------------------- +GOID: GO:0045087 +Term: innate immune response +Definition: Innate immune responses are defense responses mediated by germline encoded components that directly recognize components of potential pathogens. +-------------------------------------- +GOID: GO:0048585 +Term: negative regulation of response to stimulus +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of a response to a stimulus. Response to stimulus is a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. +-------------------------------------- +GOID: GO:0097659 +Term: nucleic acid-templated transcription +Definition: The cellular synthesis of RNA on a template of nucleic acid (DNA or RNA). +-------------------------------------- +GOID: GO:0002252 +Term: immune effector process +Definition: Any process of the immune system that can potentially contribute to an immune response. +-------------------------------------- +GOID: GO:0002684 +Term: positive regulation of immune system process +Definition: Any process that activates or increases the frequency, rate, or extent of an immune system process. +-------------------------------------- +GOID: GO:0003676 +Term: nucleic acid binding +Definition: Interacting selectively and non-covalently with any nucleic acid. +-------------------------------------- +GOID: GO:0004872 +Term: receptor activity +Definition: Combining with an extracellular or intracellular messenger to initiate a change in cell activity. +-------------------------------------- +GOID: GO:0005102 +Term: receptor binding +Definition: Interacting selectively and non-covalently with one or more specific sites on a receptor molecule, a macromolecule that undergoes combination with a hormone, neurotransmitter, drug or intracellular messenger to initiate a change in cell function. +-------------------------------------- +GOID: GO:0005794 +Term: Golgi apparatus +Definition: A compound membranous cytoplasmic organelle of eukaryotic cells, consisting of flattened, ribosome-free vesicles arranged in a more or less regular stack. The Golgi apparatus differs from the endoplasmic reticulum in often having slightly thicker membranes, appearing in sections as a characteristic shallow semicircle so that the convex side (cis or entry face) abuts the endoplasmic reticulum, secretory vesicles emerging from the concave side (trans or exit face). In vertebrate cells there is usually one such organelle, while in invertebrates and plants, where they are known usually as dictyosomes, there may be several scattered in the cytoplasm. The Golgi apparatus processes proteins produced on the ribosomes of the rough endoplasmic reticulum; such processing includes modification of the core oligosaccharides of glycoproteins, and the sorting and packaging of proteins for transport to a variety of cellular locations. Three different regions of the Golgi are now recognized both in terms of structure and function: cis, in the vicinity of the cis face, trans, in the vicinity of the trans face, and medial, lying between the cis and trans regions. +-------------------------------------- +GOID: GO:0006355 +Term: regulation of transcription, DNA-templated +Definition: Any process that modulates the frequency, rate or extent of cellular DNA-templated transcription. +-------------------------------------- +GOID: GO:0006464 +Term: cellular protein modification process +Definition: The covalent alteration of one or more amino acids occurring in proteins, peptides and nascent polypeptides (co-translational, post-translational modifications) occurring at the level of an individual cell. Includes the modification of charged tRNAs that are destined to occur in a protein (pre-translation modification). +-------------------------------------- +GOID: GO:0008283 +Term: cell proliferation +Definition: The multiplication or reproduction of cells, resulting in the expansion of a cell population. +-------------------------------------- +GOID: GO:0009653 +Term: anatomical structure morphogenesis +Definition: The process in which anatomical structures are generated and organized. Morphogenesis pertains to the creation of form. +-------------------------------------- +GOID: GO:0036211 +Term: protein modification process +Definition: The covalent alteration of one or more amino acids occurring in proteins, peptides and nascent polypeptides (co-translational, post-translational modifications). Includes the modification of charged tRNAs that are destined to occur in a protein (pre-translation modification). +-------------------------------------- +GOID: GO:0043412 +Term: macromolecule modification +Definition: The covalent alteration of one or more monomeric units in a polypeptide, polynucleotide, polysaccharide, or other biological macromolecule, resulting in a change in its properties. +-------------------------------------- +GOID: GO:0051252 +Term: regulation of RNA metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving RNA. +-------------------------------------- +GOID: GO:0051270 +Term: regulation of cellular component movement +Definition: Any process that modulates the frequency, rate or extent of the movement of a cellular component. +-------------------------------------- +GOID: GO:0051704 +Term: multi-organism process +Definition: A biological process which involves another organism of the same or different species. +-------------------------------------- +GOID: GO:0060089 +Term: molecular transducer activity +Definition: The molecular function that accepts an input of one form and creates an output of a different form. +-------------------------------------- +GOID: GO:0065009 +Term: regulation of molecular function +Definition: Any process that modulates the frequency, rate or extent of a molecular function, an elemental biological activity occurring at the molecular level, such as catalysis or binding. +-------------------------------------- +GOID: GO:0070887 +Term: cellular response to chemical stimulus +Definition: Any process that results in a change in state or activity of a cell (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a chemical stimulus. +-------------------------------------- +GOID: GO:1903506 +Term: regulation of nucleic acid-templated transcription +Definition: Any process that modulates the frequency, rate or extent of nucleic acid-templated transcription. +-------------------------------------- +GOID: GO:2000112 +Term: regulation of cellular macromolecule biosynthetic process +Definition: Any process that modulates the frequency, rate or extent of cellular macromolecule biosynthetic process. +-------------------------------------- +GOID: GO:2001141 +Term: regulation of RNA biosynthetic process +Definition: Any process that modulates the frequency, rate or extent of RNA biosynthetic process. +-------------------------------------- +GOID: GO:0016740 +Term: transferase activity +Definition: Catalysis of the transfer of a group, e.g. a methyl group, glycosyl group, acyl group, phosphorus-containing, or other groups, from one compound (generally regarded as the donor) to another compound (generally regarded as the acceptor). Transferase is the systematic name for any enzyme of EC class 2. +-------------------------------------- +GOID: GO:0030334 +Term: regulation of cell migration +Definition: Any process that modulates the frequency, rate or extent of cell migration. +-------------------------------------- +GOID: GO:0033036 +Term: macromolecule localization +Definition: Any process in which a macromolecule is transported to, or maintained in, a specific location. +-------------------------------------- +GOID: GO:0040012 +Term: regulation of locomotion +Definition: Any process that modulates the frequency, rate or extent of locomotion of a cell or organism. +-------------------------------------- +GOID: GO:0050776 +Term: regulation of immune response +Definition: Any process that modulates the frequency, rate or extent of the immune response, the immunological reaction of an organism to an immunogenic stimulus. +-------------------------------------- +GOID: GO:0050790 +Term: regulation of catalytic activity +Definition: Any process that modulates the activity of an enzyme. +-------------------------------------- +GOID: GO:0051240 +Term: positive regulation of multicellular organismal process +Definition: Any process that activates or increases the frequency, rate or extent of an organismal process, any of the processes pertinent to the function of an organism above the cellular level; includes the integrated processes of tissues and organs. +-------------------------------------- +GOID: GO:0051241 +Term: negative regulation of multicellular organismal process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of an organismal process, the processes pertinent to the function of an organism above the cellular level; includes the integrated processes of tissues and organs. +-------------------------------------- +GOID: GO:2000026 +Term: regulation of multicellular organismal development +Definition: Any process that modulates the frequency, rate or extent of multicellular organismal development. +-------------------------------------- +GOID: GO:2000145 +Term: regulation of cell motility +Definition: Any process that modulates the frequency, rate or extent of cell motility. +-------------------------------------- +GOID: GO:0002250 +Term: adaptive immune response +Definition: An immune response based on directed amplification of specific receptors for antigen produced through a somatic diversification process, and allowing for enhanced response to subsequent exposures to the same antigen (immunological memory). +-------------------------------------- +GOID: GO:0005887 +Term: integral component of plasma membrane +Definition: The component of the plasma membrane consisting of the gene products and protein complexes having at least some part of their peptide sequence embedded in the hydrophobic region of the membrane. +-------------------------------------- +GOID: GO:0006793 +Term: phosphorus metabolic process +Definition: The chemical reactions and pathways involving the nonmetallic element phosphorus or compounds that contain phosphorus, usually in the form of a phosphate group (PO4). +-------------------------------------- +GOID: GO:0006796 +Term: phosphate-containing compound metabolic process +Definition: The chemical reactions and pathways involving the phosphate group, the anion or salt of any phosphoric acid. +-------------------------------------- +GOID: GO:0006954 +Term: inflammatory response +Definition: The immediate defensive reaction (by vertebrate tissue) to infection or injury caused by chemical or physical agents. The process is characterized by local vasodilation, extravasation of plasma into intercellular spaces and accumulation of white blood cells and macrophages. +-------------------------------------- +GOID: GO:0008219 +Term: cell death +Definition: Any biological process that results in permanent cessation of all vital functions of a cell. A cell should be considered dead when any one of the following molecular or morphological criteria is met: (1) the cell has lost the integrity of its plasma membrane; (2) the cell, including its nucleus, has undergone complete fragmentation into discrete bodies (frequently referred to as apoptotic bodies). The cell corpse (or its fragments) may be engulfed by an adjacent cell in vivo, but engulfment of whole cells should not be considered a strict criteria to define cell death as, under some circumstances, live engulfed cells can be released from phagosomes (see PMID:18045538). +-------------------------------------- +GOID: GO:0010941 +Term: regulation of cell death +Definition: Any process that modulates the rate or frequency of cell death. Cell death is the specific activation or halting of processes within a cell so that its vital functions markedly cease, rather than simply deteriorating gradually over time, which culminates in cell death. +-------------------------------------- +GOID: GO:0019899 +Term: enzyme binding +Definition: Interacting selectively and non-covalently with any enzyme. +-------------------------------------- +GOID: GO:0031226 +Term: intrinsic component of plasma membrane +Definition: The component of the plasma membrane consisting of the gene products and protein complexes having either part of their peptide sequence embedded in the hydrophobic region of the membrane or some other covalently attached group such as a GPI anchor that is similarly embedded in the membrane. +-------------------------------------- +GOID: GO:0035556 +Term: intracellular signal transduction +Definition: The process in which a signal is passed on to downstream components within the cell, which become activated themselves to further propagate the signal and finally trigger a change in the function or state of the cell. +-------------------------------------- +GOID: GO:0045595 +Term: regulation of cell differentiation +Definition: Any process that modulates the frequency, rate or extent of cell differentiation, the process in which relatively unspecialized cells acquire specialized structural and functional features. +-------------------------------------- +GOID: GO:0051049 +Term: regulation of transport +Definition: Any process that modulates the frequency, rate or extent of the directed movement of substances (such as macromolecules, small molecules, ions) into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:0051128 +Term: regulation of cellular component organization +Definition: Any process that modulates the frequency, rate or extent of a process involved in the formation, arrangement of constituent parts, or disassembly of cell structures, including the plasma membrane and any external encapsulating structures such as the cell wall and cell envelope. +-------------------------------------- +GOID: GO:0072562 +Term: blood microparticle +Definition: A phospholipid microvesicle that is derived from any of several cell types, such as platelets, blood cells, endothelial cells, or others, and contains membrane receptors as well as other proteins characteristic of the parental cell. Microparticles are heterogeneous in size, and are characterized as microvesicles free of nucleic acids. +-------------------------------------- +GOID: GO:0002253 +Term: activation of immune response +Definition: Any process that initiates an immune response. +-------------------------------------- +GOID: GO:0003677 +Term: DNA binding +Definition: Any molecular function by which a gene product interacts selectively and non-covalently with DNA (deoxyribonucleic acid). +-------------------------------------- +GOID: GO:0006915 +Term: apoptotic process +Definition: A programmed cell death process which begins when a cell receives an internal (e.g. DNA damage) or external signal (e.g. an extracellular death ligand), and proceeds through a series of biochemical events (signaling pathway phase) which trigger an execution phase. The execution phase is the last step of an apoptotic process, and is typically characterized by rounding-up of the cell, retraction of pseudopodes, reduction of cellular volume (pyknosis), chromatin condensation, nuclear fragmentation (karyorrhexis), plasma membrane blebbing and fragmentation of the cell into apoptotic bodies. When the execution phase is completed, the cell has died. +-------------------------------------- +GOID: GO:0007399 +Term: nervous system development +Definition: The process whose specific outcome is the progression of nervous tissue over time, from its formation to its mature state. +-------------------------------------- +GOID: GO:0009611 +Term: response to wounding +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus indicating damage to the organism. +-------------------------------------- +GOID: GO:0010033 +Term: response to organic substance +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an organic substance stimulus. +-------------------------------------- +GOID: GO:0012501 +Term: programmed cell death +Definition: A process which begins when a cell receives an internal or external signal and activates a series of biochemical events (signaling pathway). The process ends with the death of the cell. +-------------------------------------- +GOID: GO:0030162 +Term: regulation of proteolysis +Definition: Any process that modulates the frequency, rate or extent of the hydrolysis of a peptide bond or bonds within a protein. +-------------------------------------- +GOID: GO:0031090 +Term: organelle membrane +Definition: A membrane that is one of the two lipid bilayers of an organelle envelope or the outermost membrane of single membrane bound organelle. +-------------------------------------- +GOID: GO:0042060 +Term: wound healing +Definition: The series of events that restore integrity to a damaged tissue, following an injury. +-------------------------------------- +GOID: GO:0042802 +Term: identical protein binding +Definition: Interacting selectively and non-covalently with an identical protein or proteins. +-------------------------------------- +GOID: GO:0042981 +Term: regulation of apoptotic process +Definition: Any process that modulates the occurrence or rate of cell death by apoptotic process. +-------------------------------------- +GOID: GO:0042995 +Term: cell projection +Definition: A prolongation or process extending from a cell, e.g. a flagellum or axon. +-------------------------------------- +GOID: GO:0043067 +Term: regulation of programmed cell death +Definition: Any process that modulates the frequency, rate or extent of programmed cell death, cell death resulting from activation of endogenous cellular processes. +-------------------------------------- +GOID: GO:0044085 +Term: cellular component biogenesis +Definition: A process that results in the biosynthesis of constituent macromolecules, assembly, and arrangement of constituent parts of a cellular component. Includes biosynthesis of constituent macromolecules, and those macromolecular modifications that are involved in synthesis or assembly of the cellular component. +-------------------------------------- +GOID: GO:0044877 +Term: macromolecular complex binding +Definition: Interacting selectively and non-covalently with any macromolecular complex. +-------------------------------------- +GOID: GO:0046914 +Term: transition metal ion binding +Definition: Interacting selectively and non-covalently with a transition metal ions; a transition metal is an element whose atom has an incomplete d-subshell of extranuclear electrons, or which gives rise to a cation or cations with an incomplete d-subshell. Transition metals often have more than one valency state. Biologically relevant transition metals include vanadium, manganese, iron, copper, cobalt, nickel, molybdenum and silver. +-------------------------------------- +GOID: GO:0050778 +Term: positive regulation of immune response +Definition: Any process that activates or increases the frequency, rate or extent of the immune response, the immunological reaction of an organism to an immunogenic stimulus. +-------------------------------------- +GOID: GO:0051247 +Term: positive regulation of protein metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways involving a protein. +-------------------------------------- +GOID: GO:0097367 +Term: carbohydrate derivative binding +Definition: Interacting selectively and non-covalently with a carbohydrate derivative. +-------------------------------------- +GOID: GO:0002443 +Term: leukocyte mediated immunity +Definition: Any process involved in the carrying out of an immune response by a leukocyte. +-------------------------------------- +GOID: GO:0002460 +Term: adaptive immune response based on somatic recombination of immune receptors built from immunoglobulin superfamily domains +Definition: An immune response based on directed amplification of specific receptors for antigen produced through a somatic diversification process that includes somatic recombination of germline gene segments encoding immunoglobulin superfamily domains, and allowing for enhanced responses upon subsequent exposures to the same antigen (immunological memory). Recombined receptors for antigen encoded by immunoglobulin superfamily domains include T cell receptors and immunoglobulins (antibodies). An example of this is the adaptive immune response found in Mus musculus. +-------------------------------------- +GOID: GO:0004871 +Term: signal transducer activity +Definition: Conveys a signal across a cell to trigger a change in cell function or state. A signal is a physical entity or change in state that is used to transfer information in order to trigger a response. +-------------------------------------- +GOID: GO:0006366 +Term: transcription from RNA polymerase II promoter +Definition: The synthesis of RNA from a DNA template by RNA polymerase II, originating at an RNA polymerase II promoter. Includes transcription of messenger RNA (mRNA) and certain small nuclear RNAs (snRNAs). +-------------------------------------- +GOID: GO:0006959 +Term: humoral immune response +Definition: An immune response mediated through a body fluid. +-------------------------------------- +GOID: GO:0007596 +Term: blood coagulation +Definition: The sequential process in which the multiple coagulation factors of the blood interact, ultimately resulting in the formation of an insoluble fibrin clot; it may be divided into three stages: stage 1, the formation of intrinsic and extrinsic prothrombin converting principle; stage 2, the formation of thrombin; stage 3, the formation of stable fibrin polymers. +-------------------------------------- +GOID: GO:0007599 +Term: hemostasis +Definition: The stopping of bleeding (loss of body fluid) or the arrest of the circulation to an organ or part. +-------------------------------------- +GOID: GO:0008104 +Term: protein localization +Definition: Any process in which a protein is transported to, or maintained in, a specific location. +-------------------------------------- +GOID: GO:0008233 +Term: peptidase activity +Definition: Catalysis of the hydrolysis of a peptide bond. A peptide bond is a covalent bond formed when the carbon atom from the carboxyl group of one amino acid shares electrons with the nitrogen atom from the amino group of a second amino acid. +-------------------------------------- +GOID: GO:0009056 +Term: catabolic process +Definition: The chemical reactions and pathways resulting in the breakdown of substances, including the breakdown of carbon compounds with the liberation of energy for use by the cell or organism. +-------------------------------------- +GOID: GO:0009891 +Term: positive regulation of biosynthetic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways resulting in the formation of substances. +-------------------------------------- +GOID: GO:0009967 +Term: positive regulation of signal transduction +Definition: Any process that activates or increases the frequency, rate or extent of signal transduction. +-------------------------------------- +GOID: GO:0010647 +Term: positive regulation of cell communication +Definition: Any process that increases the frequency, rate or extent of cell communication. Cell communication is the process that mediates interactions between a cell and its surroundings. Encompasses interactions such as signaling or attachment between one cell and another cell, between a cell and an extracellular matrix, or between a cell and any other aspect of its environment. +-------------------------------------- +GOID: GO:0016192 +Term: vesicle-mediated transport +Definition: A cellular transport process in which transported substances are moved in membrane-bounded vesicles; transported substances are enclosed in the vesicle lumen or located in the vesicle membrane. The process begins with a step that directs a substance to the forming vesicle, and includes vesicle budding and coating. Vesicles are then targeted to, and fuse with, an acceptor membrane. +-------------------------------------- +GOID: GO:0016310 +Term: phosphorylation +Definition: The process of introducing a phosphate group into a molecule, usually with the formation of a phosphoric ester, a phosphoric anhydride or a phosphoric amide. +-------------------------------------- +GOID: GO:0019220 +Term: regulation of phosphate metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving phosphates. +-------------------------------------- +GOID: GO:0022607 +Term: cellular component assembly +Definition: The aggregation, arrangement and bonding together of a cellular component. +-------------------------------------- +GOID: GO:0023056 +Term: positive regulation of signaling +Definition: Any process that activates, maintains or increases the frequency, rate or extent of a signaling process. +-------------------------------------- +GOID: GO:0031328 +Term: positive regulation of cellular biosynthetic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways resulting in the formation of substances, carried out by individual cells. +-------------------------------------- +GOID: GO:0031974 +Term: membrane-enclosed lumen +Definition: The enclosed volume within a sealed membrane or between two sealed membranes. Encompasses the volume enclosed by the membranes of a particular organelle, e.g. endoplasmic reticulum lumen, or the space between the two lipid bilayers of a double membrane surrounding an organelle, e.g. nuclear envelope lumen. +-------------------------------------- +GOID: GO:0032270 +Term: positive regulation of cellular protein metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways involving a protein, occurring at the level of an individual cell. +-------------------------------------- +GOID: GO:0042127 +Term: regulation of cell proliferation +Definition: Any process that modulates the frequency, rate or extent of cell proliferation. +-------------------------------------- +GOID: GO:0042592 +Term: homeostatic process +Definition: Any biological process involved in the maintenance of an internal steady state. +-------------------------------------- +GOID: GO:0043228 +Term: non-membrane-bounded organelle +Definition: Organized structure of distinctive morphology and function, not bounded by a lipid bilayer membrane. Includes ribosomes, the cytoskeleton and chromosomes. +-------------------------------------- +GOID: GO:0043232 +Term: intracellular non-membrane-bounded organelle +Definition: Organized structure of distinctive morphology and function, not bounded by a lipid bilayer membrane and occurring within the cell. Includes ribosomes, the cytoskeleton and chromosomes. +-------------------------------------- +GOID: GO:0043233 +Term: organelle lumen +Definition: The internal volume enclosed by the membranes of a particular organelle; includes the volume enclosed by a single organelle membrane, e.g. endoplasmic reticulum lumen, or the volume enclosed by the innermost of the two lipid bilayers of an organelle envelope, e.g. nuclear lumen. +-------------------------------------- +GOID: GO:0043933 +Term: macromolecular complex subunit organization +Definition: Any process in which macromolecules aggregate, disaggregate, or are modified, resulting in the formation, disassembly, or alteration of a macromolecular complex. +-------------------------------------- +GOID: GO:0044711 +Term: single-organism biosynthetic process +Definition: A biosynthetic process - chemical reactions and pathways resulting in the formation of substances - involving a single organism. +-------------------------------------- +GOID: GO:0046983 +Term: protein dimerization activity +Definition: The formation of a protein dimer, a macromolecular structure consists of two noncovalently associated identical or nonidentical subunits. +-------------------------------------- +GOID: GO:0048468 +Term: cell development +Definition: The process whose specific outcome is the progression of the cell over time, from its formation to the mature structure. Cell development does not include the steps involved in committing a cell to a specific fate. +-------------------------------------- +GOID: GO:0050817 +Term: coagulation +Definition: The process in which a fluid solution, or part of it, changes into a solid or semisolid mass. +-------------------------------------- +GOID: GO:0050878 +Term: regulation of body fluid levels +Definition: Any process that modulates the levels of body fluids. +-------------------------------------- +GOID: GO:0051093 +Term: negative regulation of developmental process +Definition: Any process that stops, prevents or reduces the rate or extent of development, the biological process whose specific outcome is the progression of an organism over time from an initial condition (e.g. a zygote, or a young adult) to a later condition (e.g. a multicellular animal or an aged adult). +-------------------------------------- +GOID: GO:0051174 +Term: regulation of phosphorus metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving phosphorus or compounds containing phosphorus. +-------------------------------------- +GOID: GO:0051248 +Term: negative regulation of protein metabolic process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of chemical reactions and pathways involving a protein. +-------------------------------------- +GOID: GO:0070011 +Term: peptidase activity, acting on L-amino acid peptides +Definition: Catalysis of the hydrolysis of peptide bonds formed between L-amino acids. +-------------------------------------- +GOID: GO:0070013 +Term: intracellular organelle lumen +Definition: An organelle lumen that is part of an intracellular organelle. +-------------------------------------- +GOID: GO:0071702 +Term: organic substance transport +Definition: The directed movement of organic substances into, out of or within a cell, or between cells, or within a multicellular organism by means of some agent such as a transporter or pore. An organic substance is a molecular entity that contains carbon. +-------------------------------------- +GOID: GO:0072376 +Term: protein activation cascade +Definition: A response to a stimulus that consists of a sequential series of modifications to a set of proteins where the product of one reaction acts catalytically in the following reaction. The magnitude of the response is typically amplified at each successive step in the cascade. Modifications typically include proteolysis or covalent modification, and may also include binding events. +-------------------------------------- +GOID: GO:0098588 +Term: bounding membrane of organelle +Definition: The lipid bilayer that forms the outer-most layer of an organelle. +-------------------------------------- +GOID: GO:1901135 +Term: carbohydrate derivative metabolic process +Definition: The chemical reactions and pathways involving carbohydrate derivative. +-------------------------------------- +GOID: GO:0001071 +Term: nucleic acid binding transcription factor activity +Definition: Interacting selectively and non-covalently with a DNA or RNA sequence in order to modulate transcription. The transcription factor may or may not also interact selectively with a protein or macromolecular complex. +-------------------------------------- +GOID: GO:0002449 +Term: lymphocyte mediated immunity +Definition: Any process involved in the carrying out of an immune response by a lymphocyte. +-------------------------------------- +GOID: GO:0003008 +Term: system process +Definition: A multicellular organismal process carried out by any of the organs or tissues in an organ system. An organ system is a regularly interacting or interdependent group of organs or tissues that work together to carry out a biological objective. +-------------------------------------- +GOID: GO:0003700 +Term: transcription factor activity, sequence-specific DNA binding +Definition: Interacting selectively and non-covalently with a specific DNA sequence in order to modulate transcription. The transcription factor may or may not also interact selectively with a protein or macromolecular complex. +-------------------------------------- +GOID: GO:0004175 +Term: endopeptidase activity +Definition: Catalysis of the hydrolysis of internal, alpha-peptide bonds in a polypeptide chain. +-------------------------------------- +GOID: GO:0005509 +Term: calcium ion binding +Definition: Interacting selectively and non-covalently with calcium ions (Ca2+). +-------------------------------------- +GOID: GO:0006357 +Term: regulation of transcription from RNA polymerase II promoter +Definition: Any process that modulates the frequency, rate or extent of transcription from an RNA polymerase II promoter. +-------------------------------------- +GOID: GO:0006468 +Term: protein phosphorylation +Definition: The process of introducing a phosphate group on to a protein. +-------------------------------------- +GOID: GO:0006956 +Term: complement activation +Definition: Any process involved in the activation of any of the steps of the complement cascade, which allows for the direct killing of microbes, the disposal of immune complexes, and the regulation of other immune processes; the initial steps of complement activation involve one of three pathways, the classical pathway, the alternative pathway, and the lectin pathway, all of which lead to the terminal complement pathway. +-------------------------------------- +GOID: GO:0006996 +Term: organelle organization +Definition: A process that is carried out at the cellular level which results in the assembly, arrangement of constituent parts, or disassembly of an organelle within a cell. An organelle is an organized structure of distinctive morphology and function. Includes the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0007155 +Term: cell adhesion +Definition: The attachment of a cell, either to another cell or to an underlying substrate such as the extracellular matrix, via cell adhesion molecules. +-------------------------------------- +GOID: GO:0009888 +Term: tissue development +Definition: The process whose specific outcome is the progression of a tissue over time, from its formation to the mature structure. +-------------------------------------- +GOID: GO:0010562 +Term: positive regulation of phosphorus metabolic process +Definition: Any process that increases the frequency, rate or extent of the chemical reactions and pathways involving phosphorus or compounds containing phosphorus. +-------------------------------------- +GOID: GO:0022008 +Term: neurogenesis +Definition: Generation of cells within the nervous system. +-------------------------------------- +GOID: GO:0022610 +Term: biological adhesion +Definition: The attachment of a cell or organism to a substrate, another cell, or other organism. Biological adhesion includes intracellular attachment between membrane regions. +-------------------------------------- +GOID: GO:0023057 +Term: negative regulation of signaling +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of a signaling process. +-------------------------------------- +GOID: GO:0030335 +Term: positive regulation of cell migration +Definition: Any process that activates or increases the frequency, rate or extent of cell migration. +-------------------------------------- +GOID: GO:0031981 +Term: nuclear lumen +Definition: The volume enclosed by the nuclear inner membrane. +-------------------------------------- +GOID: GO:0040017 +Term: positive regulation of locomotion +Definition: Any process that activates or increases the frequency, rate or extent of locomotion of a cell or organism. +-------------------------------------- +GOID: GO:0042325 +Term: regulation of phosphorylation +Definition: Any process that modulates the frequency, rate or extent of addition of phosphate groups into a molecule. +-------------------------------------- +GOID: GO:0044093 +Term: positive regulation of molecular function +Definition: Any process that activates or increases the rate or extent of a molecular function, an elemental biological activity occurring at the molecular level, such as catalysis or binding. +-------------------------------------- +GOID: GO:0044428 +Term: nuclear part +Definition: Any constituent part of the nucleus, a membrane-bounded organelle of eukaryotic cells in which chromosomes are housed and replicated. +-------------------------------------- +GOID: GO:0045937 +Term: positive regulation of phosphate metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways involving phosphates. +-------------------------------------- +GOID: GO:0051173 +Term: positive regulation of nitrogen compound metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways involving nitrogen or nitrogenous compounds. +-------------------------------------- +GOID: GO:0051272 +Term: positive regulation of cellular component movement +Definition: Any process that activates or increases the frequency, rate or extent of the movement of a cellular component. +-------------------------------------- +GOID: GO:0051336 +Term: regulation of hydrolase activity +Definition: Any process that modulates the frequency, rate or extent of hydrolase activity, the catalysis of the hydrolysis of various bonds, e.g. C-O, C-N, C-C, phosphoric anhydride bonds, etc. Hydrolase is the systematic name for any enzyme of EC class 3. +-------------------------------------- +GOID: GO:0065003 +Term: macromolecular complex assembly +Definition: The aggregation, arrangement and bonding together of a set of macromolecules to form a complex. +-------------------------------------- +GOID: GO:1901137 +Term: carbohydrate derivative biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of carbohydrate derivative. +-------------------------------------- +GOID: GO:1901564 +Term: organonitrogen compound metabolic process +Definition: The chemical reactions and pathways involving organonitrogen compound. +-------------------------------------- +GOID: GO:1901575 +Term: organic substance catabolic process +Definition: The chemical reactions and pathways resulting in the breakdown of an organic substance, any molecular entity containing carbon. +-------------------------------------- +GOID: GO:2000147 +Term: positive regulation of cell motility +Definition: Any process that activates or increases the frequency, rate or extent of cell motility. +-------------------------------------- +GOID: GO:0000003 +Term: reproduction +Definition: The production of new individuals that contain some portion of genetic material inherited from one or more parent organisms. +-------------------------------------- +GOID: GO:0001816 +Term: cytokine production +Definition: The appearance of a cytokine due to biosynthesis or secretion following a cellular stimulus, resulting in an increase in its intracellular or extracellular levels. +-------------------------------------- +GOID: GO:0001817 +Term: regulation of cytokine production +Definition: Any process that modulates the frequency, rate, or extent of production of a cytokine. +-------------------------------------- +GOID: GO:0001932 +Term: regulation of protein phosphorylation +Definition: Any process that modulates the frequency, rate or extent of addition of phosphate groups into an amino acid in a protein. +-------------------------------------- +GOID: GO:0002526 +Term: acute inflammatory response +Definition: Inflammation which comprises a rapid, short-lived, relatively uniform response to acute injury or antigenic challenge and is characterized by accumulations of fluid, plasma proteins, and granulocytic leukocytes. An acute inflammatory response occurs within a matter of minutes or hours, and either resolves within a few days or becomes a chronic inflammatory response. +-------------------------------------- +GOID: GO:0004252 +Term: serine-type endopeptidase activity +Definition: Catalysis of the hydrolysis of internal, alpha-peptide bonds in a polypeptide chain by a catalytic mechanism that involves a catalytic triad consisting of a serine nucleophile that is activated by a proton relay involving an acidic residue (e.g. aspartate or glutamate) and a basic residue (usually histidine). +-------------------------------------- +GOID: GO:0004888 +Term: transmembrane signaling receptor activity +Definition: Combining with an extracellular or intracellular signal and transmitting the signal from one side of the membrane to the other to initiate a change in cell activity or state as part of signal transduction. +-------------------------------------- +GOID: GO:0005215 +Term: transporter activity +Definition: Enables the directed movement of substances (such as macromolecules, small molecules, ions) into, out of or within a cell, or between cells. +-------------------------------------- +GOID: GO:0005975 +Term: carbohydrate metabolic process +Definition: The chemical reactions and pathways involving carbohydrates, any of a group of organic compounds based of the general formula Cx(H2O)y. Includes the formation of carbohydrate derivatives by the addition of a carbohydrate residue to another molecule. +-------------------------------------- +GOID: GO:0006461 +Term: protein complex assembly +Definition: The aggregation, arrangement and bonding together of a set of components to form a protein complex. +-------------------------------------- +GOID: GO:0006629 +Term: lipid metabolic process +Definition: The chemical reactions and pathways involving lipids, compounds soluble in an organic solvent but not, or sparingly, in an aqueous solvent. Includes fatty acids; neutral fats, other fatty-acid esters, and soaps; long-chain (fatty) alcohols and waxes; sphingoids and other long-chain bases; glycolipids, phospholipids and sphingolipids; and carotenes, polyprenols, sterols, terpenes and other isoprenoids. +-------------------------------------- +GOID: GO:0006897 +Term: endocytosis +Definition: A vesicle-mediated transport process in which cells take up external materials or membrane constituents by the invagination of a small region of the plasma membrane to form a new membrane-bounded vesicle. +-------------------------------------- +GOID: GO:0007267 +Term: cell-cell signaling +Definition: Any process that mediates the transfer of information from one cell to another. This process includes signal transduction in the receiving cell and, where applicable, release of a ligand and any processes that actively facilitate its transport and presentation to the receiving cell. Examples include signaling via soluble ligands, via cell adhesion molecules and via gap junctions. +-------------------------------------- +GOID: GO:0008236 +Term: serine-type peptidase activity +Definition: Catalysis of the hydrolysis of peptide bonds in a polypeptide chain by a catalytic mechanism that involves a catalytic triad consisting of a serine nucleophile that is activated by a proton relay involving an acidic residue (e.g. aspartate or glutamate) and a basic residue (usually histidine). +-------------------------------------- +GOID: GO:0009607 +Term: response to biotic stimulus +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a biotic stimulus, a stimulus caused or produced by a living organism. +-------------------------------------- +GOID: GO:0009887 +Term: animal organ morphogenesis +Definition: Morphogenesis of an animal organ. An organ is defined as a tissue or set of tissues that work together to perform a specific function or functions. Morphogenesis is the process in which anatomical structures are generated and organized. Organs are commonly observed as visibly distinct structures, but may also exist as loosely associated clusters of cells that work together to perform a specific function or functions. +-------------------------------------- +GOID: GO:0009968 +Term: negative regulation of signal transduction +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of signal transduction. +-------------------------------------- +GOID: GO:0009986 +Term: cell surface +Definition: The external part of the cell wall and/or plasma membrane. +-------------------------------------- +GOID: GO:0010557 +Term: positive regulation of macromolecule biosynthetic process +Definition: Any process that increases the rate, frequency or extent of the chemical reactions and pathways resulting in the formation of a macromolecule, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0010628 +Term: positive regulation of gene expression +Definition: Any process that increases the frequency, rate or extent of gene expression. Gene expression is the process in which a gene's coding sequence is converted into a mature gene product or products (proteins or RNA). This includes the production of an RNA transcript as well as any processing to produce a mature RNA product or an mRNA (for protein-coding genes) and the translation of that mRNA into protein. Protein maturation is included when required to form an active form of a product from an inactive precursor form. +-------------------------------------- +GOID: GO:0010629 +Term: negative regulation of gene expression +Definition: Any process that decreases the frequency, rate or extent of gene expression. Gene expression is the process in which a gene's coding sequence is converted into a mature gene product or products (proteins or RNA). This includes the production of an RNA transcript as well as any processing to produce a mature RNA product or an mRNA (for protein-coding genes) and the translation of that mRNA into protein. Protein maturation is included when required to form an active form of a product from an inactive precursor form. +-------------------------------------- +GOID: GO:0010648 +Term: negative regulation of cell communication +Definition: Any process that decreases the frequency, rate or extent of cell communication. Cell communication is the process that mediates interactions between a cell and its surroundings. Encompasses interactions such as signaling or attachment between one cell and another cell, between a cell and an extracellular matrix, or between a cell and any other aspect of its environment. +-------------------------------------- +GOID: GO:0016064 +Term: immunoglobulin mediated immune response +Definition: An immune response mediated by immunoglobulins, whether cell-bound or in solution. +-------------------------------------- +GOID: GO:0017171 +Term: serine hydrolase activity +Definition: Catalysis of the hydrolysis of a substrate by a catalytic mechanism that involves a catalytic triad consisting of a serine nucleophile that is activated by a proton relay involving an acidic residue (e.g. aspartate or glutamate) and a basic residue (usually histidine). +-------------------------------------- +GOID: GO:0019724 +Term: B cell mediated immunity +Definition: Any process involved with the carrying out of an immune response by a B cell, through, for instance, the production of antibodies or cytokines, or antigen presentation to T cells. +-------------------------------------- +GOID: GO:0022414 +Term: reproductive process +Definition: A biological process that directly contributes to the process of producing new individuals by one or two organisms. The new individuals inherit some proportion of their genetic material from the parent or parents. +-------------------------------------- +GOID: GO:0022603 +Term: regulation of anatomical structure morphogenesis +Definition: Any process that modulates the frequency, rate or extent of anatomical structure morphogenesis. +-------------------------------------- +GOID: GO:0030054 +Term: cell junction +Definition: A cellular component that forms a specialized region of connection between two or more cells or between a cell and the extracellular matrix. At a cell junction, anchoring proteins extend through the plasma membrane to link cytoskeletal proteins in one cell to cytoskeletal proteins in neighboring cells or to proteins in the extracellular matrix. +-------------------------------------- +GOID: GO:0030193 +Term: regulation of blood coagulation +Definition: Any process that modulates the frequency, rate or extent of blood coagulation. +-------------------------------------- +GOID: GO:0031347 +Term: regulation of defense response +Definition: Any process that modulates the frequency, rate or extent of a defense response. +-------------------------------------- +GOID: GO:0031399 +Term: regulation of protein modification process +Definition: Any process that modulates the frequency, rate or extent of the covalent alteration of one or more amino acid residues within a protein. +-------------------------------------- +GOID: GO:0032102 +Term: negative regulation of response to external stimulus +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of a response to an external stimulus. +-------------------------------------- +GOID: GO:0032269 +Term: negative regulation of cellular protein metabolic process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of the chemical reactions and pathways involving a protein, occurring at the level of an individual cell. +-------------------------------------- +GOID: GO:0033554 +Term: cellular response to stress +Definition: Any process that results in a change in state or activity of a cell (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus indicating the organism is under stress. The stress is usually, but not necessarily, exogenous (e.g. temperature, humidity, ionizing radiation). +-------------------------------------- +GOID: GO:0036094 +Term: small molecule binding +Definition: Interacting selectively and non-covalently with a small molecule, any low molecular weight, monomeric, non-encoded molecule. +-------------------------------------- +GOID: GO:0038023 +Term: signaling receptor activity +Definition: Receiving a signal and transmitting the signal in the cell to initiate a change in cell activity. A signal is a physical entity or change in state that is used to transfer information in order to trigger a response. +-------------------------------------- +GOID: GO:0040007 +Term: growth +Definition: The increase in size or mass of an entire organism, a part of an organism or a cell. +-------------------------------------- +GOID: GO:0043207 +Term: response to external biotic stimulus +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an external biotic stimulus, an external stimulus caused by, or produced by living things. +-------------------------------------- +GOID: GO:0044431 +Term: Golgi apparatus part +Definition: Any constituent part of the Golgi apparatus, a compound membranous cytoplasmic organelle of eukaryotic cells, consisting of flattened, ribosome-free vesicles arranged in a more or less regular stack. +-------------------------------------- +GOID: GO:0044723 +Term: single-organism carbohydrate metabolic process +Definition: The chemical reactions and pathways involving carbohydrates, occurring within a single organism. +-------------------------------------- +GOID: GO:0045184 +Term: establishment of protein localization +Definition: The directed movement of a protein to a specific location. +-------------------------------------- +GOID: GO:0045935 +Term: positive regulation of nucleobase-containing compound metabolic process +Definition: Any cellular process that activates or increases the frequency, rate or extent of the chemical reactions and pathways involving nucleobases, nucleosides, nucleotides and nucleic acids. +-------------------------------------- +GOID: GO:0048699 +Term: generation of neurons +Definition: The process in which nerve cells are generated. This includes the production of neuroblasts and their differentiation into neurons. +-------------------------------------- +GOID: GO:0050818 +Term: regulation of coagulation +Definition: Any process that modulates the frequency, rate or extent of coagulation, the process in which a fluid solution, or part of it, changes into a solid or semisolid mass. +-------------------------------------- +GOID: GO:0050900 +Term: leukocyte migration +Definition: The movement of a leukocyte within or between different tissues and organs of the body. +-------------------------------------- +GOID: GO:0051050 +Term: positive regulation of transport +Definition: Any process that activates or increases the frequency, rate or extent of the directed movement of substances (such as macromolecules, small molecules, ions) into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:0051094 +Term: positive regulation of developmental process +Definition: Any process that activates or increases the rate or extent of development, the biological process whose specific outcome is the progression of an organism over time from an initial condition (e.g. a zygote, or a young adult) to a later condition (e.g. a multicellular animal or an aged adult). +-------------------------------------- +GOID: GO:0051707 +Term: response to other organism +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus from another living organism. +-------------------------------------- +GOID: GO:0061041 +Term: regulation of wound healing +Definition: Any process that modulates the rate, frequency, or extent of the series of events that restore integrity to a damaged tissue, following an injury. +-------------------------------------- +GOID: GO:0070271 +Term: protein complex biogenesis +Definition: A cellular process that results in the biosynthesis of constituent macromolecules, assembly, and arrangement of constituent parts of a protein complex. Includes the synthesis of non-protein components, and those protein modifications that are involved in synthesis or assembly of the complex. +-------------------------------------- +GOID: GO:0071822 +Term: protein complex subunit organization +Definition: Any process in which macromolecules aggregate, disaggregate, or are modified, resulting in the formation, disassembly, or alteration of a protein complex. +-------------------------------------- +GOID: GO:0098542 +Term: defense response to other organism +Definition: Reactions triggered in response to the presence of another organism that act to protect the cell or organism from damage caused by that organism. +-------------------------------------- +GOID: GO:0099600 +Term: transmembrane receptor activity +Definition: Combining with an extracellular or intracellular signal and transmitting a signal from one side of the membrane to the other. +-------------------------------------- +GOID: GO:1900046 +Term: regulation of hemostasis +Definition: Any process that modulates the frequency, rate or extent of hemostasis. +-------------------------------------- +GOID: GO:1902531 +Term: regulation of intracellular signal transduction +Definition: Any process that modulates the frequency, rate or extent of intracellular signal transduction. +-------------------------------------- +GOID: GO:1903034 +Term: regulation of response to wounding +Definition: Any process that modulates the frequency, rate or extent of response to wounding. +-------------------------------------- +GOID: GO:0000166 +Term: nucleotide binding +Definition: Interacting selectively and non-covalently with a nucleotide, any compound consisting of a nucleoside that is esterified with (ortho)phosphate or an oligophosphate at any hydroxyl group on the ribose or deoxyribose. +-------------------------------------- +GOID: GO:0000323 +Term: lytic vacuole +Definition: A vacuole that is maintained at an acidic pH and which contains degradative enzymes, including a wide variety of acid hydrolases. +-------------------------------------- +GOID: GO:0001882 +Term: nucleoside binding +Definition: Interacting selectively and non-covalently with a nucleoside, a compound consisting of a purine or pyrimidine nitrogenous base linked either to ribose or deoxyribose. +-------------------------------------- +GOID: GO:0001883 +Term: purine nucleoside binding +Definition: Interacting selectively and non-covalently with a purine nucleoside, a compound consisting of a purine base linked either to ribose or deoxyribose. +-------------------------------------- +GOID: GO:0001934 +Term: positive regulation of protein phosphorylation +Definition: Any process that activates or increases the frequency, rate or extent of addition of phosphate groups to amino acids within a protein. +-------------------------------------- +GOID: GO:0002455 +Term: humoral immune response mediated by circulating immunoglobulin +Definition: An immune response dependent upon secreted immunoglobulin. An example of this process is found in Mus musculus. +-------------------------------------- +GOID: GO:0005654 +Term: nucleoplasm +Definition: That part of the nuclear content other than the chromosomes or the nucleolus. +-------------------------------------- +GOID: GO:0005739 +Term: mitochondrion +Definition: A semiautonomous, self replicating organelle that occurs in varying numbers, shapes, and sizes in the cytoplasm of virtually all eukaryotic cells. It is notably the site of tissue respiration. +-------------------------------------- +GOID: GO:0005764 +Term: lysosome +Definition: A small lytic vacuole that has cell cycle-independent morphology and is found in most animal cells and that contains a variety of hydrolases, most of which have their maximal activities in the pH range 5-6. The contained enzymes display latency if properly isolated. About 40 different lysosomal hydrolases are known and lysosomes have a great variety of morphologies and functions. +-------------------------------------- +GOID: GO:0005773 +Term: vacuole +Definition: A closed structure, found only in eukaryotic cells, that is completely surrounded by unit membrane and contains liquid material. Cells contain one or several vacuoles, that may have different functions from each other. Vacuoles have a diverse array of functions. They can act as a storage organelle for nutrients or waste products, as a degradative compartment, as a cost-effective way of increasing cell size, and as a homeostatic regulator controlling both turgor pressure and pH of the cytosol. +-------------------------------------- +GOID: GO:0006935 +Term: chemotaxis +Definition: The directed movement of a motile cell or organism, or the directed growth of a cell guided by a specific chemical concentration gradient. Movement may be towards a higher concentration (positive chemotaxis) or towards a lower concentration (negative chemotaxis). +-------------------------------------- +GOID: GO:0006958 +Term: complement activation, classical pathway +Definition: Any process involved in the activation of any of the steps of the classical pathway of the complement cascade which allows for the direct killing of microbes, the disposal of immune complexes, and the regulation of other immune processes. +-------------------------------------- +GOID: GO:0007186 +Term: G-protein coupled receptor signaling pathway +Definition: A series of molecular signals that proceeds with an activated receptor promoting the exchange of GDP for GTP on the alpha-subunit of an associated heterotrimeric G-protein complex. The GTP-bound activated alpha-G-protein then dissociates from the beta- and gamma-subunits to further transmit the signal within the cell. The pathway begins with receptor-ligand interaction, or for basal GPCR signaling the pathway begins with the receptor activating its G protein in the absence of an agonist, and ends with regulation of a downstream cellular process, e.g. transcription. The pathway can start from the plasma membrane, Golgi or nuclear membrane (PMID:24568158 and PMID:16902576). +-------------------------------------- +GOID: GO:0008270 +Term: zinc ion binding +Definition: Interacting selectively and non-covalently with zinc (Zn) ions. +-------------------------------------- +GOID: GO:0009057 +Term: macromolecule catabolic process +Definition: The chemical reactions and pathways resulting in the breakdown of a macromolecule, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0009100 +Term: glycoprotein metabolic process +Definition: The chemical reactions and pathways involving glycoproteins, any protein that contains covalently bound glycose (i.e. monosaccharide) residues; the glycose occurs most commonly as oligosaccharide or fairly small polysaccharide but occasionally as monosaccharide. +-------------------------------------- +GOID: GO:0009101 +Term: glycoprotein biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of glycoproteins, any protein that contains covalently bound glycose (i.e. monosaccharide) residues; the glycose occurs most commonly as oligosaccharide or fairly small polysaccharide but occasionally as monosaccharide. +-------------------------------------- +GOID: GO:0009628 +Term: response to abiotic stimulus +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an abiotic (non-living) stimulus. +-------------------------------------- +GOID: GO:0009790 +Term: embryo development +Definition: The process whose specific outcome is the progression of an embryo from its formation until the end of its embryonic life stage. The end of the embryonic stage is organism-specific. For example, for mammals, the process would begin with zygote formation and end with birth. For insects, the process would begin at zygote formation and end with larval hatching. For plant zygotic embryos, this would be from zygote formation to the end of seed dormancy. For plant vegetative embryos, this would be from the initial determination of the cell or group of cells to form an embryo until the point when the embryo becomes independent of the parent plant. +-------------------------------------- +GOID: GO:0009890 +Term: negative regulation of biosynthetic process +Definition: Any process that stops, prevents, or reduces the rate of the chemical reactions and pathways resulting in the formation of substances. +-------------------------------------- +GOID: GO:0010558 +Term: negative regulation of macromolecule biosynthetic process +Definition: Any process that decreases the rate, frequency or extent of the chemical reactions and pathways resulting in the formation of a macromolecule, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0015031 +Term: protein transport +Definition: The directed movement of proteins into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:0016757 +Term: transferase activity, transferring glycosyl groups +Definition: Catalysis of the transfer of a glycosyl group from one compound (donor) to another (acceptor). +-------------------------------------- +GOID: GO:0017076 +Term: purine nucleotide binding +Definition: Interacting selectively and non-covalently with purine nucleotides, any compound consisting of a purine nucleoside esterified with (ortho)phosphate. +-------------------------------------- +GOID: GO:0019953 +Term: sexual reproduction +Definition: A reproduction process that creates a new organism by combining the genetic material of two organisms. It occurs both in eukaryotes and prokaryotes: in multicellular eukaryotic organisms, an individual is created anew; in prokaryotes, the initial cell has additional or transformed genetic material. In a process called genetic recombination, genetic material (DNA) originating from two different individuals (parents) join up so that homologous sequences are aligned with each other, and this is followed by exchange of genetic information. After the new recombinant chromosome is formed, it is passed on to progeny. +-------------------------------------- +GOID: GO:0030182 +Term: neuron differentiation +Definition: The process in which a relatively unspecialized cell acquires specialized features of a neuron. +-------------------------------------- +GOID: GO:0031327 +Term: negative regulation of cellular biosynthetic process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of the chemical reactions and pathways resulting in the formation of substances, carried out by individual cells. +-------------------------------------- +GOID: GO:0031401 +Term: positive regulation of protein modification process +Definition: Any process that activates or increases the frequency, rate or extent of the covalent alteration of one or more amino acid residues within a protein. +-------------------------------------- +GOID: GO:0031410 +Term: cytoplasmic vesicle +Definition: A vesicle found in the cytoplasm of a cell. +-------------------------------------- +GOID: GO:0032403 +Term: protein complex binding +Definition: Interacting selectively and non-covalently with any protein complex (a complex of two or more proteins that may include other nonprotein molecules). +-------------------------------------- +GOID: GO:0032549 +Term: ribonucleoside binding +Definition: Interacting selectively and non-covalently with a ribonucleoside, a compound consisting of a purine or pyrimidine nitrogenous base linked to ribose. +-------------------------------------- +GOID: GO:0032550 +Term: purine ribonucleoside binding +Definition: Interacting selectively and non-covalently with a purine ribonucleoside, a compound consisting of a purine base linked to ribose. +-------------------------------------- +GOID: GO:0032553 +Term: ribonucleotide binding +Definition: Interacting selectively and non-covalently with a ribonucleotide, any compound consisting of a ribonucleoside that is esterified with (ortho)phosphate or an oligophosphate at any hydroxyl group on the ribose moiety. +-------------------------------------- +GOID: GO:0032555 +Term: purine ribonucleotide binding +Definition: Interacting selectively and non-covalently with a purine ribonucleotide, any compound consisting of a purine ribonucleoside that is esterified with (ortho)phosphate or an oligophosphate at any hydroxyl group on the ribose moiety. +-------------------------------------- +GOID: GO:0035639 +Term: purine ribonucleoside triphosphate binding +Definition: Interacting selectively and non-covalently with a purine ribonucleoside triphosphate, a compound consisting of a purine base linked to a ribose sugar esterified with triphosphate on the sugar. +-------------------------------------- +GOID: GO:0042327 +Term: positive regulation of phosphorylation +Definition: Any process that activates or increases the frequency, rate or extent of addition of phosphate groups to a molecule. +-------------------------------------- +GOID: GO:0042330 +Term: taxis +Definition: The directed movement of a motile cell or organism in response to an external stimulus. +-------------------------------------- +GOID: GO:0043085 +Term: positive regulation of catalytic activity +Definition: Any process that activates or increases the activity of an enzyme. +-------------------------------------- +GOID: GO:0044248 +Term: cellular catabolic process +Definition: The chemical reactions and pathways resulting in the breakdown of substances, carried out by individual cells. +-------------------------------------- +GOID: GO:0044281 +Term: small molecule metabolic process +Definition: The chemical reactions and pathways involving small molecules, any low molecular weight, monomeric, non-encoded molecule. +-------------------------------------- +GOID: GO:0044702 +Term: single organism reproductive process +Definition: A biological process that directly contributes to the process of producing new individuals, involving a single organism. +-------------------------------------- +GOID: GO:0044703 +Term: multi-organism reproductive process +Definition: A biological process that directly contributes to the process of producing new individuals, involving another organism. +-------------------------------------- +GOID: GO:0045596 +Term: negative regulation of cell differentiation +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of cell differentiation. +-------------------------------------- +GOID: GO:0045893 +Term: positive regulation of transcription, DNA-templated +Definition: Any process that activates or increases the frequency, rate or extent of cellular DNA-templated transcription. +-------------------------------------- +GOID: GO:0046982 +Term: protein heterodimerization activity +Definition: Interacting selectively and non-covalently with a nonidentical protein to form a heterodimer. +-------------------------------------- +GOID: GO:0050877 +Term: neurological system process +Definition: A organ system process carried out by any of the organs or tissues of neurological system. +-------------------------------------- +GOID: GO:0051130 +Term: positive regulation of cellular component organization +Definition: Any process that activates or increases the frequency, rate or extent of a process involved in the formation, arrangement of constituent parts, or disassembly of cell structures, including the plasma membrane and any external encapsulating structures such as the cell wall and cell envelope. +-------------------------------------- +GOID: GO:0051172 +Term: negative regulation of nitrogen compound metabolic process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of the chemical reactions and pathways involving nitrogen or nitrogenous compounds. +-------------------------------------- +GOID: GO:0051254 +Term: positive regulation of RNA metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways involving RNA. +-------------------------------------- +GOID: GO:0051641 +Term: cellular localization +Definition: A localization process that takes place at the cellular level; as a result of a cellular localization process, a substance or cellular entity, such as a protein complex or organelle, is transported to, and/or maintained in, a specific location within or in the membrane of a cell. +-------------------------------------- +GOID: GO:0052547 +Term: regulation of peptidase activity +Definition: Any process that modulates the frequency, rate or extent of peptidase activity, the hydrolysis of peptide bonds within proteins. +-------------------------------------- +GOID: GO:0055114 +Term: oxidation-reduction process +Definition: A metabolic process that results in the removal or addition of one or more electrons to or from a substance, with or without the concomitant removal or addition of a proton or protons. +-------------------------------------- +GOID: GO:0072359 +Term: circulatory system development +Definition: The process whose specific outcome is the progression of the circulatory system over time, from its formation to the mature structure. The circulatory system is the organ system that passes nutrients (such as amino acids and electrolytes), gases, hormones, blood cells, etc. to and from cells in the body to help fight diseases and help stabilize body temperature and pH to maintain homeostasis. +-------------------------------------- +GOID: GO:0097458 +Term: neuron part +Definition: Any constituent part of a neuron, the basic cellular unit of nervous tissue. A typical neuron consists of a cell body (often called the soma), an axon, and dendrites. Their purpose is to receive, conduct, and transmit impulses in the nervous system. +-------------------------------------- +GOID: GO:0097708 +Term: intracellular vesicle +Definition: Any vesicle that is part of the intracellular region. +-------------------------------------- +GOID: GO:1901265 +Term: nucleoside phosphate binding +Definition: Interacting selectively and non-covalently with nucleoside phosphate. +-------------------------------------- +GOID: GO:1901566 +Term: organonitrogen compound biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of organonitrogen compound. +-------------------------------------- +GOID: GO:1902680 +Term: positive regulation of RNA biosynthetic process +Definition: Any process that activates or increases the frequency, rate or extent of RNA biosynthetic process. +-------------------------------------- +GOID: GO:1903508 +Term: positive regulation of nucleic acid-templated transcription +Definition: Any process that activates or increases the frequency, rate or extent of nucleic acid-templated transcription. +-------------------------------------- +GOID: GO:0000975 +Term: regulatory region DNA binding +Definition: Interacting selectively and non-covalently with a DNA region that regulates a DNA-based process. Such processes include transcription, DNA replication, and DNA repair. +-------------------------------------- +GOID: GO:0001067 +Term: regulatory region nucleic acid binding +Definition: Interacting selectively and non-covalently with a nucleic acid region that regulates a nucleic acid-based process. Such processes include transcription, DNA replication, and DNA repair. +-------------------------------------- +GOID: GO:0001775 +Term: cell activation +Definition: A change in the morphology or behavior of a cell resulting from exposure to an activating factor such as a cellular or soluble ligand. +-------------------------------------- +GOID: GO:0002683 +Term: negative regulation of immune system process +Definition: Any process that stops, prevents, or reduces the frequency, rate, or extent of an immune system process. +-------------------------------------- +GOID: GO:0002685 +Term: regulation of leukocyte migration +Definition: Any process that modulates the frequency, rate, or extent of leukocyte migration. +-------------------------------------- +GOID: GO:0003006 +Term: developmental process involved in reproduction +Definition: A developmental process in which a progressive change in the state of some part of an organism specifically contributes to its ability to form offspring. +-------------------------------------- +GOID: GO:0003682 +Term: chromatin binding +Definition: Interacting selectively and non-covalently with chromatin, the network of fibers of DNA, protein, and sometimes RNA, that make up the chromosomes of the eukaryotic nucleus during interphase. +-------------------------------------- +GOID: GO:0005768 +Term: endosome +Definition: A vacuole to which materials ingested by endocytosis are delivered. +-------------------------------------- +GOID: GO:0006486 +Term: protein glycosylation +Definition: A protein modification process that results in the addition of a carbohydrate or carbohydrate derivative unit to a protein amino acid, e.g. the addition of glycan chains to proteins. +-------------------------------------- +GOID: GO:0006909 +Term: phagocytosis +Definition: An endocytosis process that results in the engulfment of external particulate material by phagocytes. The particles are initially contained within phagocytic vacuoles (phagosomes), which then fuse with primary lysosomes to effect digestion of the particles. +-------------------------------------- +GOID: GO:0007049 +Term: cell cycle +Definition: The progression of biochemical and morphological phases and events that occur in a cell during successive cell replication or nuclear replication events. Canonically, the cell cycle comprises the replication and segregation of genetic material followed by the division of the cell, but in endocycles or syncytial cells nuclear replication or nuclear division may not be followed by cell division. +-------------------------------------- +GOID: GO:0007167 +Term: enzyme linked receptor protein signaling pathway +Definition: Any series of molecular signals initiated by the binding of an extracellular ligand to a receptor on the surface of the target cell, where the receptor possesses catalytic activity or is closely associated with an enzyme such as a protein kinase, and ending with regulation of a downstream cellular process, e.g. transcription. +-------------------------------------- +GOID: GO:0007169 +Term: transmembrane receptor protein tyrosine kinase signaling pathway +Definition: A series of molecular signals initiated by the binding of an extracellular ligand to a receptor on the surface of the target cell where the receptor possesses tyrosine kinase activity, and ending with regulation of a downstream cellular process, e.g. transcription. +-------------------------------------- +GOID: GO:0007423 +Term: sensory organ development +Definition: The process whose specific outcome is the progression of sensory organs over time, from its formation to the mature structure. +-------------------------------------- +GOID: GO:0007600 +Term: sensory perception +Definition: The series of events required for an organism to receive a sensory stimulus, convert it to a molecular signal, and recognize and characterize the signal. This is a neurological process. +-------------------------------------- +GOID: GO:0008134 +Term: transcription factor binding +Definition: Interacting selectively and non-covalently with a transcription factor, any protein required to initiate or regulate transcription. +-------------------------------------- +GOID: GO:0008289 +Term: lipid binding +Definition: Interacting selectively and non-covalently with a lipid. +-------------------------------------- +GOID: GO:0008610 +Term: lipid biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of lipids, compounds soluble in an organic solvent but not, or sparingly, in an aqueous solvent. +-------------------------------------- +GOID: GO:0009311 +Term: oligosaccharide metabolic process +Definition: The chemical reactions and pathways involving oligosaccharides, molecules with between two and (about) 20 monosaccharide residues connected by glycosidic linkages. +-------------------------------------- +GOID: GO:0010942 +Term: positive regulation of cell death +Definition: Any process that increases the rate or frequency of cell death. Cell death is the specific activation or halting of processes within a cell so that its vital functions markedly cease, rather than simply deteriorating gradually over time, which culminates in cell death. +-------------------------------------- +GOID: GO:0016485 +Term: protein processing +Definition: Any protein maturation process achieved by the cleavage of a peptide bond or bonds within a protein. Protein maturation is the process leading to the attainment of the full functional capacity of a protein. +-------------------------------------- +GOID: GO:0016491 +Term: oxidoreductase activity +Definition: Catalysis of an oxidation-reduction (redox) reaction, a reversible chemical reaction in which the oxidation state of an atom or atoms within a molecule is altered. One substrate acts as a hydrogen or electron donor and becomes oxidized, while the other acts as hydrogen or electron acceptor and becomes reduced. +-------------------------------------- +GOID: GO:0018193 +Term: peptidyl-amino acid modification +Definition: The alteration of an amino acid residue in a peptide. +-------------------------------------- +GOID: GO:0019725 +Term: cellular homeostasis +Definition: Any process involved in the maintenance of an internal steady state at the level of the cell. +-------------------------------------- +GOID: GO:0019900 +Term: kinase binding +Definition: Interacting selectively and non-covalently with a kinase, any enzyme that catalyzes the transfer of a phosphate group. +-------------------------------------- +GOID: GO:0019901 +Term: protein kinase binding +Definition: Interacting selectively and non-covalently with a protein kinase, any enzyme that catalyzes the transfer of a phosphate group, usually from ATP, to a protein substrate. +-------------------------------------- +GOID: GO:0022892 +Term: substrate-specific transporter activity +Definition: Enables the directed movement of a specific substance or group of related substances (such as macromolecules, small molecules, ions) into, out of or within a cell, or between cells. +-------------------------------------- +GOID: GO:0030155 +Term: regulation of cell adhesion +Definition: Any process that modulates the frequency, rate or extent of attachment of a cell to another cell or to the extracellular matrix. +-------------------------------------- +GOID: GO:0030163 +Term: protein catabolic process +Definition: The chemical reactions and pathways resulting in the breakdown of a protein by the destruction of the native, active configuration, with or without the hydrolysis of peptide bonds. +-------------------------------------- +GOID: GO:0030195 +Term: negative regulation of blood coagulation +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of blood coagulation. +-------------------------------------- +GOID: GO:0030198 +Term: extracellular matrix organization +Definition: A process that is carried out at the cellular level which results in the assembly, arrangement of constituent parts, or disassembly of an extracellular matrix. +-------------------------------------- +GOID: GO:0030234 +Term: enzyme regulator activity +Definition: Binds to and modulates the activity of an enzyme. +-------------------------------------- +GOID: GO:0030246 +Term: carbohydrate binding +Definition: Interacting selectively and non-covalently with any carbohydrate, which includes monosaccharides, oligosaccharides and polysaccharides as well as substances derived from monosaccharides by reduction of the carbonyl group (alditols), by oxidation of one or more hydroxy groups to afford the corresponding aldehydes, ketones, or carboxylic acids, or by replacement of one or more hydroxy group(s) by a hydrogen atom. Cyclitols are generally not regarded as carbohydrates. +-------------------------------------- +GOID: GO:0032103 +Term: positive regulation of response to external stimulus +Definition: Any process that activates, maintains or increases the rate of a response to an external stimulus. +-------------------------------------- +GOID: GO:0032940 +Term: secretion by cell +Definition: The controlled release of a substance by a cell. +-------------------------------------- +GOID: GO:0034622 +Term: cellular macromolecular complex assembly +Definition: The aggregation, arrangement and bonding together of a set of macromolecules to form a complex, carried out at the cellular level. +-------------------------------------- +GOID: GO:0036477 +Term: somatodendritic compartment +Definition: The region of a neuron that includes the cell body (cell soma) and the dendrite, but excludes the axon. +-------------------------------------- +GOID: GO:0040008 +Term: regulation of growth +Definition: Any process that modulates the frequency, rate or extent of the growth of all or part of an organism so that it occurs at its proper speed, either globally or in a specific part of the organism's development. +-------------------------------------- +GOID: GO:0042730 +Term: fibrinolysis +Definition: A process that solubilizes fibrin in the bloodstream of a multicellular organism, chiefly by the proteolytic action of plasmin. +-------------------------------------- +GOID: GO:0042803 +Term: protein homodimerization activity +Definition: Interacting selectively and non-covalently with an identical protein to form a homodimer. +-------------------------------------- +GOID: GO:0043005 +Term: neuron projection +Definition: A prolongation or process extending from a nerve cell, e.g. an axon or dendrite. +-------------------------------------- +GOID: GO:0043062 +Term: extracellular structure organization +Definition: A process that is carried out at the cellular level which results in the assembly, arrangement of constituent parts, or disassembly of structures in the space external to the outermost structure of a cell. For cells without external protective or external encapsulating structures this refers to space outside of the plasma membrane, and also covers the host cell environment outside an intracellular parasite. +-------------------------------------- +GOID: GO:0043066 +Term: negative regulation of apoptotic process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of cell death by apoptotic process. +-------------------------------------- +GOID: GO:0043069 +Term: negative regulation of programmed cell death +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of programmed cell death, cell death resulting from activation of endogenous cellular processes. +-------------------------------------- +GOID: GO:0043086 +Term: negative regulation of catalytic activity +Definition: Any process that stops or reduces the activity of an enzyme. +-------------------------------------- +GOID: GO:0043413 +Term: macromolecule glycosylation +Definition: The covalent attachment of a glycosyl residue to one or more monomeric units in a polypeptide, polynucleotide, polysaccharide, or other biological macromolecule. +-------------------------------------- +GOID: GO:0043565 +Term: sequence-specific DNA binding +Definition: Interacting selectively and non-covalently with DNA of a specific nucleotide composition, e.g. GC-rich DNA binding, or with a specific sequence motif or type of DNA e.g. promotor binding or rDNA binding. +-------------------------------------- +GOID: GO:0043603 +Term: cellular amide metabolic process +Definition: The chemical reactions and pathways involving an amide, any derivative of an oxoacid in which an acidic hydroxy group has been replaced by an amino or substituted amino group, as carried out by individual cells. +-------------------------------------- +GOID: GO:0044092 +Term: negative regulation of molecular function +Definition: Any process that stops or reduces the rate or extent of a molecular function, an elemental biological activity occurring at the molecular level, such as catalysis or binding. +-------------------------------------- +GOID: GO:0044212 +Term: transcription regulatory region DNA binding +Definition: Interacting selectively and non-covalently with a DNA region that regulates the transcription of a region of DNA, which may be a gene, cistron, or operon. Binding may occur as a sequence specific interaction or as an interaction observed only once a factor has been recruited to the DNA by other factors. +-------------------------------------- +GOID: GO:0044265 +Term: cellular macromolecule catabolic process +Definition: The chemical reactions and pathways resulting in the breakdown of a macromolecule, any large molecule including proteins, nucleic acids and carbohydrates, as carried out by individual cells. +-------------------------------------- +GOID: GO:0045861 +Term: negative regulation of proteolysis +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of the hydrolysis of a peptide bond or bonds within a protein. +-------------------------------------- +GOID: GO:0045934 +Term: negative regulation of nucleobase-containing compound metabolic process +Definition: Any cellular process that stops, prevents, or reduces the frequency, rate or extent of the chemical reactions and pathways involving nucleobases, nucleosides, nucleotides and nucleic acids. +-------------------------------------- +GOID: GO:0045944 +Term: positive regulation of transcription from RNA polymerase II promoter +Definition: Any process that activates or increases the frequency, rate or extent of transcription from an RNA polymerase II promoter. +-------------------------------------- +GOID: GO:0046903 +Term: secretion +Definition: The controlled release of a substance by a cell or a tissue. +-------------------------------------- +GOID: GO:0048589 +Term: developmental growth +Definition: The increase in size or mass of an entire organism, a part of an organism or a cell, where the increase in size or mass has the specific outcome of the progression of the organism over time from one condition to another. +-------------------------------------- +GOID: GO:0048646 +Term: anatomical structure formation involved in morphogenesis +Definition: The developmental process pertaining to the initial formation of an anatomical structure from unspecified parts. This process begins with the specific processes that contribute to the appearance of the discrete structure and ends when the structural rudiment is recognizable. An anatomical structure is any biological entity that occupies space and is distinguished from its surroundings. Anatomical structures can be macroscopic such as a carpel, or microscopic such as an acrosome. +-------------------------------------- +GOID: GO:0050767 +Term: regulation of neurogenesis +Definition: Any process that modulates the frequency, rate or extent of neurogenesis, the origin and formation of neurons. +-------------------------------------- +GOID: GO:0050819 +Term: negative regulation of coagulation +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of coagulation. +-------------------------------------- +GOID: GO:0050839 +Term: cell adhesion molecule binding +Definition: Interacting selectively and non-covalently with a cell adhesion molecule. +-------------------------------------- +GOID: GO:0050920 +Term: regulation of chemotaxis +Definition: Any process that modulates the frequency, rate or extent of the directed movement of a motile cell or organism in response to a specific chemical concentration gradient. +-------------------------------------- +GOID: GO:0051604 +Term: protein maturation +Definition: Any process leading to the attainment of the full functional capacity of a protein. +-------------------------------------- +GOID: GO:0051960 +Term: regulation of nervous system development +Definition: Any process that modulates the frequency, rate or extent of nervous system development, the origin and formation of nervous tissue. +-------------------------------------- +GOID: GO:0060284 +Term: regulation of cell development +Definition: Any process that modulates the rate, frequency or extent of the progression of the cell over time, from its formation to the mature structure. Cell development does not include the steps involved in committing a cell to a specific fate. +-------------------------------------- +GOID: GO:0060326 +Term: cell chemotaxis +Definition: The directed movement of a motile cell guided by a specific chemical concentration gradient. Movement may be towards a higher concentration (positive chemotaxis) or towards a lower concentration (negative chemotaxis). +-------------------------------------- +GOID: GO:0060548 +Term: negative regulation of cell death +Definition: Any process that decreases the rate or frequency of cell death. Cell death is the specific activation or halting of processes within a cell so that its vital functions markedly cease, rather than simply deteriorating gradually over time, which culminates in cell death. +-------------------------------------- +GOID: GO:0060627 +Term: regulation of vesicle-mediated transport +Definition: Any process that modulates the rate, frequency, or extent of vesicle-mediated transport, the directed movement of substances, either within a vesicle or in the vesicle membrane, into, out of or within a cell. +-------------------------------------- +GOID: GO:0061045 +Term: negative regulation of wound healing +Definition: Any process that decreases the rate, frequency, or extent of the series of events that restore integrity to a damaged tissue, following an injury. +-------------------------------------- +GOID: GO:0061134 +Term: peptidase regulator activity +Definition: Modulates the activity of a peptidase, any enzyme that catalyzes the hydrolysis peptide bonds. +-------------------------------------- +GOID: GO:0070085 +Term: glycosylation +Definition: The covalent attachment and further modification of carbohydrate residues to a substrate molecule. +-------------------------------------- +GOID: GO:0070161 +Term: anchoring junction +Definition: A cell junction that mechanically attaches a cell (and its cytoskeleton) to neighboring cells or to the extracellular matrix. +-------------------------------------- +GOID: GO:0071310 +Term: cellular response to organic substance +Definition: Any process that results in a change in state or activity of a cell (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an organic substance stimulus. +-------------------------------------- +GOID: GO:0097190 +Term: apoptotic signaling pathway +Definition: A series of molecular signals which triggers the apoptotic death of a cell. The pathway starts with reception of a signal, and ends when the execution phase of apoptosis is triggered. +-------------------------------------- +GOID: GO:0098590 +Term: plasma membrane region +Definition: A membrane that is a (regional) part of the plasma membrane. +-------------------------------------- +GOID: GO:0098609 +Term: cell-cell adhesion +Definition: The attachment of one cell to another cell via adhesion molecules. +-------------------------------------- +GOID: GO:0098772 +Term: molecular function regulator +Definition: A molecular function that modulates the activity of a gene product or complex. Examples include enzyme regulators and channel regulators. +-------------------------------------- +GOID: GO:0098796 +Term: membrane protein complex +Definition: Any protein complex that is part of a membrane. +-------------------------------------- +GOID: GO:0098805 +Term: whole membrane +Definition: Any lipid bilayer that completely encloses some structure, and all the proteins embedded in it or attached to it. Examples include the plasma membrane and most organelle membranes. +-------------------------------------- +GOID: GO:1900047 +Term: negative regulation of hemostasis +Definition: Any process that stops, prevents or reduces the frequency, rate or extent of hemostasis. +-------------------------------------- +GOID: GO:1902533 +Term: positive regulation of intracellular signal transduction +Definition: Any process that activates or increases the frequency, rate or extent of intracellular signal transduction. +-------------------------------------- +GOID: GO:1903035 +Term: negative regulation of response to wounding +Definition: Any process that stops, prevents or reduces the frequency, rate or extent of response to wounding. +-------------------------------------- +GOID: GO:2000113 +Term: negative regulation of cellular macromolecule biosynthetic process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of cellular macromolecule biosynthetic process. +-------------------------------------- + +-------------------------------------- +cluster: 4 +-------------------------------------- + +-------------------------------------- +GOID: GO:0003674 +Term: molecular_function +Definition: Elemental activities, such as catalysis or binding, describing the actions of a gene product at the molecular level. A given gene product may exhibit one or more molecular functions. +-------------------------------------- +GOID: GO:0008150 +Term: biological_process +Definition: Any process specifically pertinent to the functioning of integrated living units: cells, tissues, organs, and organisms. A process is a collection of molecular events with a defined beginning and end. +-------------------------------------- +GOID: GO:0005575 +Term: cellular_component +Definition: The part of a cell or its extracellular environment in which a gene product is located. A gene product may be located in one or more parts of a cell and its location may be as specific as a particular macromolecular complex, that is, a stable, persistent association of macromolecules that function together. +-------------------------------------- +GOID: GO:0009987 +Term: cellular process +Definition: Any process that is carried out at the cellular level, but not necessarily restricted to a single cell. For example, cell communication occurs among more than one cell, but occurs at the cellular level. +-------------------------------------- +GOID: GO:0044699 +Term: single-organism process +Definition: A biological process that involves only one organism. +-------------------------------------- +GOID: GO:0005488 +Term: binding +Definition: The selective, non-covalent, often stoichiometric, interaction of a molecule with one or more specific sites on another molecule. +-------------------------------------- +GOID: GO:0043226 +Term: organelle +Definition: Organized structure of distinctive morphology and function. Includes the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton, and prokaryotic structures such as anammoxosomes and pirellulosomes. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0065007 +Term: biological regulation +Definition: Any process that modulates a measurable attribute of any biological process, quality or function. +-------------------------------------- +GOID: GO:0043227 +Term: membrane-bounded organelle +Definition: Organized structure of distinctive morphology and function, bounded by a single or double lipid bilayer membrane. Includes the nucleus, mitochondria, plastids, vacuoles, and vesicles. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0044763 +Term: single-organism cellular process +Definition: Any process that is carried out at the cellular level, occurring within a single organism. +-------------------------------------- +GOID: GO:0005623 +Term: cell +Definition: The basic structural and functional unit of all organisms. Includes the plasma membrane and any external encapsulating structures such as the cell wall and cell envelope. +-------------------------------------- +GOID: GO:0044464 +Term: cell part +Definition: Any constituent part of a cell, the basic structural and functional unit of all organisms. +-------------------------------------- +GOID: GO:0050789 +Term: regulation of biological process +Definition: Any process that modulates the frequency, rate or extent of a biological process. Biological processes are regulated by many means; examples include the control of gene expression, protein modification or interaction with a protein or substrate molecule. +-------------------------------------- +GOID: GO:0050794 +Term: regulation of cellular process +Definition: Any process that modulates the frequency, rate or extent of a cellular process, any of those that are carried out at the cellular level, but are not necessarily restricted to a single cell. For example, cell communication occurs among more than one cell, but occurs at the cellular level. +-------------------------------------- +GOID: GO:0050896 +Term: response to stimulus +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. The process begins with detection of the stimulus and ends with a change in state or activity or the cell or organism. +-------------------------------------- +GOID: GO:0005622 +Term: intracellular +Definition: The living contents of a cell; the matter contained within (but not including) the plasma membrane, usually taken to exclude large vacuoles and masses of secretory or ingested material. In eukaryotes it includes the nucleus and cytoplasm. +-------------------------------------- +GOID: GO:0016020 +Term: membrane +Definition: A lipid bilayer along with all the proteins and protein complexes embedded in it an attached to it. +-------------------------------------- +GOID: GO:0044424 +Term: intracellular part +Definition: Any constituent part of the living contents of a cell; the matter contained within (but not including) the plasma membrane, usually taken to exclude large vacuoles and masses of secretory or ingested material. In eukaryotes it includes the nucleus and cytoplasm. +-------------------------------------- +GOID: GO:0008152 +Term: metabolic process +Definition: The chemical reactions and pathways, including anabolism and catabolism, by which living organisms transform chemical substances. Metabolic processes typically transform small molecules, but also include macromolecular processes such as DNA repair and replication, and protein synthesis and degradation. +-------------------------------------- +GOID: GO:0005515 +Term: protein binding +Definition: Interacting selectively and non-covalently with any protein or protein complex (a complex of two or more proteins that may include other nonprotein molecules). +-------------------------------------- +GOID: GO:0005737 +Term: cytoplasm +Definition: All of the contents of a cell excluding the plasma membrane and nucleus, but including other subcellular structures. +-------------------------------------- +GOID: GO:0043229 +Term: intracellular organelle +Definition: Organized structure of distinctive morphology and function, occurring within the cell. Includes the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0071704 +Term: organic substance metabolic process +Definition: The chemical reactions and pathways involving an organic substance, any molecular entity containing carbon. +-------------------------------------- +GOID: GO:0044238 +Term: primary metabolic process +Definition: The chemical reactions and pathways involving those compounds which are formed as a part of the normal anabolic and catabolic processes. These processes take place in most, if not all, cells of the organism. +-------------------------------------- +GOID: GO:0051179 +Term: localization +Definition: Any process in which a cell, a substance, or a cellular entity, such as a protein complex or organelle, is transported, tethered to or otherwise maintained in a specific location. In the case of substances, localization may also be achieved via selective degradation. +-------------------------------------- +GOID: GO:0005576 +Term: extracellular region +Definition: The space external to the outermost structure of a cell. For cells without external protective or external encapsulating structures this refers to space outside of the plasma membrane. This term covers the host cell environment outside an intracellular parasite. +-------------------------------------- +GOID: GO:0043231 +Term: intracellular membrane-bounded organelle +Definition: Organized structure of distinctive morphology and function, bounded by a single or double lipid bilayer membrane and occurring within the cell. Includes the nucleus, mitochondria, plastids, vacuoles, and vesicles. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0044237 +Term: cellular metabolic process +Definition: The chemical reactions and pathways by which individual cells transform chemical substances. +-------------------------------------- +GOID: GO:0044421 +Term: extracellular region part +Definition: Any constituent part of the extracellular region, the space external to the outermost structure of a cell. For cells without external protective or external encapsulating structures this refers to space outside of the plasma membrane. This term covers constituent parts of the host cell environment outside an intracellular parasite. +-------------------------------------- +GOID: GO:0031982 +Term: vesicle +Definition: Any small, fluid-filled, spherical organelle enclosed by membrane. +-------------------------------------- +GOID: GO:0043170 +Term: macromolecule metabolic process +Definition: The chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0044425 +Term: membrane part +Definition: Any constituent part of a membrane, a double layer of lipid molecules that encloses all cells, and, in eukaryotes, many organelles; may be a single or double lipid bilayer; also includes associated proteins. +-------------------------------------- +GOID: GO:0044444 +Term: cytoplasmic part +Definition: Any constituent part of the cytoplasm, all of the contents of a cell excluding the plasma membrane and nucleus, but including other subcellular structures. +-------------------------------------- +GOID: GO:0051716 +Term: cellular response to stimulus +Definition: Any process that results in a change in state or activity of a cell (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. The process begins with detection of the stimulus by a cell and ends with a change in state or activity or the cell. +-------------------------------------- +GOID: GO:0006810 +Term: transport +Definition: The directed movement of substances (such as macromolecules, small molecules, ions) or cellular components (such as complexes and organelles) into, out of or within a cell, or between cells, or within a multicellular organism by means of some agent such as a transporter, pore or motor protein. +-------------------------------------- +GOID: GO:0032501 +Term: multicellular organismal process +Definition: Any biological process, occurring at the level of a multicellular organism, pertinent to its function. +-------------------------------------- +GOID: GO:0042221 +Term: response to chemical +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a chemical stimulus. +-------------------------------------- +GOID: GO:0051234 +Term: establishment of localization +Definition: Any process that localizes a substance or cellular component. This may occur via movement, tethering or selective degradation. +-------------------------------------- +GOID: GO:0006950 +Term: response to stress +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a disturbance in organismal or cellular homeostasis, usually, but not necessarily, exogenous (e.g. temperature, humidity, ionizing radiation). +-------------------------------------- +GOID: GO:0048518 +Term: positive regulation of biological process +Definition: Any process that activates or increases the frequency, rate or extent of a biological process. Biological processes are regulated by many means; examples include the control of gene expression, protein modification or interaction with a protein or substrate molecule. +-------------------------------------- +GOID: GO:0031988 +Term: membrane-bounded vesicle +Definition: Any small, fluid-filled, spherical organelle enclosed by a lipid bilayer. +-------------------------------------- +GOID: GO:0005886 +Term: plasma membrane +Definition: The membrane surrounding a cell that separates the cell from its external environment. It consists of a phospholipid bilayer and associated proteins. +-------------------------------------- +GOID: GO:0043230 +Term: extracellular organelle +Definition: Organized structure of distinctive morphology and function, occurring outside the cell. Includes, for example, extracellular membrane vesicles (EMVs) and the cellulosomes of anaerobic bacteria and fungi. +-------------------------------------- +GOID: GO:0044707 +Term: single-multicellular organism process +Definition: A biological process occurring within a single, multicellular organism. +-------------------------------------- +GOID: GO:0048519 +Term: negative regulation of biological process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of a biological process. Biological processes are regulated by many means; examples include the control of gene expression, protein modification or interaction with a protein or substrate molecule. +-------------------------------------- +GOID: GO:0070062 +Term: extracellular exosome +Definition: A membrane-bounded vesicle that is released into the extracellular region by fusion of the limiting endosomal membrane of a multivesicular body with the plasma membrane. Extracellular exosomes, also simply called exosomes, have a diameter of about 40-100 nm. +-------------------------------------- +GOID: GO:0071944 +Term: cell periphery +Definition: The part of a cell encompassing the cell cortex, the plasma membrane, and any external encapsulating structures. +-------------------------------------- +GOID: GO:1903561 +Term: extracellular vesicle +Definition: Any vesicle that is part of the extracellular region. +-------------------------------------- +GOID: GO:0007154 +Term: cell communication +Definition: Any process that mediates interactions between a cell and its surroundings. Encompasses interactions such as signaling or attachment between one cell and another cell, between a cell and an extracellular matrix, or between a cell and any other aspect of its environment. +-------------------------------------- +GOID: GO:0048522 +Term: positive regulation of cellular process +Definition: Any process that activates or increases the frequency, rate or extent of a cellular process, any of those that are carried out at the cellular level, but are not necessarily restricted to a single cell. For example, cell communication occurs among more than one cell, but occurs at the cellular level. +-------------------------------------- +GOID: GO:0007165 +Term: signal transduction +Definition: The cellular process in which a signal is conveyed to trigger a change in the activity or state of a cell. Signal transduction begins with reception of a signal (e.g. a ligand binding to a receptor or receptor activation by a stimulus such as light), or for signal transduction in the absence of ligand, signal-withdrawal or the activity of a constitutively active receptor. Signal transduction ends with regulation of a downstream cellular process, e.g. regulation of transcription or regulation of a metabolic process. Signal transduction covers signaling from receptors located on the surface of the cell and signaling via molecules located within the cell. For signaling between cells, signal transduction is restricted to events at and within the receiving cell. +-------------------------------------- +GOID: GO:0023052 +Term: signaling +Definition: The entirety of a process in which information is transmitted within a biological system. This process begins with an active signal and ends when a cellular response has been triggered. +-------------------------------------- +GOID: GO:0044700 +Term: single organism signaling +Definition: A signaling process occurring within a single organism. +-------------------------------------- +GOID: GO:0019538 +Term: protein metabolic process +Definition: The chemical reactions and pathways involving a specific protein, rather than of proteins in general. Includes protein modification. +-------------------------------------- +GOID: GO:0044260 +Term: cellular macromolecule metabolic process +Definition: The chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass, as carried out by individual cells. +-------------------------------------- +GOID: GO:0005615 +Term: extracellular space +Definition: That part of a multicellular organism outside the cells proper, usually taken to be outside the plasma membranes, and occupied by fluid. +-------------------------------------- +GOID: GO:0031224 +Term: intrinsic component of membrane +Definition: The component of a membrane consisting of the gene products having some covalently attached portion, for example part of a peptide sequence or some other covalently attached group such as a GPI anchor, which spans or is embedded in one or both leaflets of the membrane. +-------------------------------------- +GOID: GO:0032502 +Term: developmental process +Definition: A biological process whose specific outcome is the progression of an integrated living unit: an anatomical structure (which may be a subcellular structure, cell, tissue, or organ), or organism over time from an initial condition to a later condition. +-------------------------------------- +GOID: GO:0044765 +Term: single-organism transport +Definition: The directed movement of substances (such as macromolecules, small molecules, ions) into, out of or within a cell, or between cells, or within a multicellular organism by means of some agent such as a transporter or pore, involving a single organism. +-------------------------------------- +GOID: GO:0044767 +Term: single-organism developmental process +Definition: A biological process whose specific outcome is the progression of an integrated living unit: an anatomical structure (which may be a subcellular structure, cell, tissue, or organ), or organism over time from an initial condition to a later condition, involving only one organism. +-------------------------------------- +GOID: GO:0048523 +Term: negative regulation of cellular process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of a cellular process, any of those that are carried out at the cellular level, but are not necessarily restricted to a single cell. For example, cell communication occurs among more than one cell, but occurs at the cellular level. +-------------------------------------- +GOID: GO:1902578 +Term: single-organism localization +Definition: A localization which involves only one organism. +-------------------------------------- +GOID: GO:0003824 +Term: catalytic activity +Definition: Catalysis of a biochemical reaction at physiological temperatures. In biologically catalyzed reactions, the reactants are known as substrates, and the catalysts are naturally occurring macromolecular substances known as enzymes. Enzymes possess specific binding sites for substrates, and are usually composed wholly or largely of protein, but RNA that has catalytic activity (ribozyme) is often also regarded as enzymatic. +-------------------------------------- +GOID: GO:0019222 +Term: regulation of metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways within a cell or an organism. +-------------------------------------- +GOID: GO:0048583 +Term: regulation of response to stimulus +Definition: Any process that modulates the frequency, rate or extent of a response to a stimulus. Response to stimulus is a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. +-------------------------------------- +GOID: GO:0048856 +Term: anatomical structure development +Definition: The biological process whose specific outcome is the progression of an anatomical structure from an initial condition to its mature state. This process begins with the formation of the structure and ends with the mature structure, whatever form that may be including its natural destruction. An anatomical structure is any biological entity that occupies space and is distinguished from its surroundings. Anatomical structures can be macroscopic such as a carpel, or microscopic such as an acrosome. +-------------------------------------- +GOID: GO:0071840 +Term: cellular component organization or biogenesis +Definition: A process that results in the biosynthesis of constituent macromolecules, assembly, arrangement of constituent parts, or disassembly of a cellular component. +-------------------------------------- +GOID: GO:0006807 +Term: nitrogen compound metabolic process +Definition: The chemical reactions and pathways involving organic or inorganic compounds that contain nitrogen, including (but not limited to) nitrogen fixation, nitrification, denitrification, assimilatory/dissimilatory nitrate reduction and the interconversion of nitrogenous organic matter and ammonium. +-------------------------------------- +GOID: GO:0007275 +Term: multicellular organism development +Definition: The biological process whose specific outcome is the progression of a multicellular organism over time from an initial condition (e.g. a zygote or a young adult) to a later condition (e.g. a multicellular animal or an aged adult). +-------------------------------------- +GOID: GO:0009605 +Term: response to external stimulus +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an external stimulus. +-------------------------------------- +GOID: GO:0012505 +Term: endomembrane system +Definition: A collection of membranous structures involved in transport within the cell. The main components of the endomembrane system are endoplasmic reticulum, Golgi bodies, vesicles, cell membrane and nuclear envelope. Members of the endomembrane system pass materials through each other or though the use of vesicles. +-------------------------------------- +GOID: GO:0016021 +Term: integral component of membrane +Definition: The component of a membrane consisting of the gene products and protein complexes having at least some part of their peptide sequence embedded in the hydrophobic region of the membrane. +-------------------------------------- +GOID: GO:0016043 +Term: cellular component organization +Definition: A process that results in the assembly, arrangement of constituent parts, or disassembly of a cellular component. +-------------------------------------- +GOID: GO:0031323 +Term: regulation of cellular metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways by which individual cells transform chemical substances. +-------------------------------------- +GOID: GO:0048731 +Term: system development +Definition: The process whose specific outcome is the progression of an organismal system over time, from its formation to the mature structure. A system is a regularly interacting or interdependent group of organs or tissues that work together to carry out a given biological process. +-------------------------------------- +GOID: GO:0060255 +Term: regulation of macromolecule metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0002376 +Term: immune system process +Definition: Any process involved in the development or functioning of the immune system, an organismal system for calibrated responses to potential internal or invasive threats. +-------------------------------------- +GOID: GO:0006952 +Term: defense response +Definition: Reactions, triggered in response to the presence of a foreign body or the occurrence of an injury, which result in restriction of damage to the organism attacked or prevention/recovery from the infection caused by the attack. +-------------------------------------- +GOID: GO:0065008 +Term: regulation of biological quality +Definition: Any process that modulates a qualitative or quantitative trait of a biological quality. A biological quality is a measurable attribute of an organism or part of an organism, such as size, mass, shape, color, etc. +-------------------------------------- +GOID: GO:0070887 +Term: cellular response to chemical stimulus +Definition: Any process that results in a change in state or activity of a cell (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a chemical stimulus. +-------------------------------------- +GOID: GO:0071702 +Term: organic substance transport +Definition: The directed movement of organic substances into, out of or within a cell, or between cells, or within a multicellular organism by means of some agent such as a transporter or pore. An organic substance is a molecular entity that contains carbon. +-------------------------------------- +GOID: GO:0080090 +Term: regulation of primary metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways within a cell or an organism involving those compounds formed as a part of the normal anabolic and catabolic processes. These processes take place in most, if not all, cells of the organism. +-------------------------------------- +GOID: GO:0009058 +Term: biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of substances; typically the energy-requiring part of metabolism in which simpler substances are transformed into more complex ones. +-------------------------------------- +GOID: GO:0030154 +Term: cell differentiation +Definition: The process in which relatively unspecialized cells, e.g. embryonic or regenerative cells, acquire specialized structural and/or functional features that characterize the cells, tissues, or organs of the mature organism or some other relatively stable phase of the organism's life history. Differentiation includes the processes involved in commitment of a cell to a specific fate and its subsequent development to the mature state. +-------------------------------------- +GOID: GO:0032879 +Term: regulation of localization +Definition: Any process that modulates the frequency, rate or extent of any process in which a cell, a substance, or a cellular entity is transported to, or maintained in, a specific location. +-------------------------------------- +GOID: GO:0035556 +Term: intracellular signal transduction +Definition: The process in which a signal is passed on to downstream components within the cell, which become activated themselves to further propagate the signal and finally trigger a change in the function or state of the cell. +-------------------------------------- +GOID: GO:0043167 +Term: ion binding +Definition: Interacting selectively and non-covalently with ions, charged atoms or groups of atoms. +-------------------------------------- +GOID: GO:0043169 +Term: cation binding +Definition: Interacting selectively and non-covalently with cations, charged atoms or groups of atoms with a net positive charge. +-------------------------------------- +GOID: GO:0044249 +Term: cellular biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of substances, carried out by individual cells. +-------------------------------------- +GOID: GO:0046872 +Term: metal ion binding +Definition: Interacting selectively and non-covalently with any metal ion. +-------------------------------------- +GOID: GO:0048869 +Term: cellular developmental process +Definition: A biological process whose specific outcome is the progression of a cell over time from an initial condition to a later condition. +-------------------------------------- +GOID: GO:0005634 +Term: nucleus +Definition: A membrane-bounded organelle of eukaryotic cells in which chromosomes are housed and replicated. In most cells, the nucleus contains all of the cell's chromosomes except the organellar chromosomes, and is the site of RNA synthesis and processing. In some species, or in specialized cell types, RNA metabolism or DNA replication may be absent. +-------------------------------------- +GOID: GO:0044267 +Term: cellular protein metabolic process +Definition: The chemical reactions and pathways involving a specific protein, rather than of proteins in general, occurring at the level of an individual cell. Includes cellular protein modification. +-------------------------------------- +GOID: GO:0044422 +Term: organelle part +Definition: Any constituent part of an organelle, an organized structure of distinctive morphology and function. Includes constituent parts of the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton, but excludes the plasma membrane. +-------------------------------------- +GOID: GO:0044446 +Term: intracellular organelle part +Definition: A constituent part of an intracellular organelle, an organized structure of distinctive morphology and function, occurring within the cell. Includes constituent parts of the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton but excludes the plasma membrane. +-------------------------------------- +GOID: GO:0051239 +Term: regulation of multicellular organismal process +Definition: Any process that modulates the frequency, rate or extent of a multicellular organismal process, the processes pertinent to the function of a multicellular organism above the cellular level; includes the integrated processes of tissues and organs. +-------------------------------------- +GOID: GO:1901576 +Term: organic substance biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of an organic substance, any molecular entity containing carbon. +-------------------------------------- +GOID: GO:0008219 +Term: cell death +Definition: Any biological process that results in permanent cessation of all vital functions of a cell. A cell should be considered dead when any one of the following molecular or morphological criteria is met: (1) the cell has lost the integrity of its plasma membrane; (2) the cell, including its nucleus, has undergone complete fragmentation into discrete bodies (frequently referred to as apoptotic bodies). The cell corpse (or its fragments) may be engulfed by an adjacent cell in vivo, but engulfment of whole cells should not be considered a strict criteria to define cell death as, under some circumstances, live engulfed cells can be released from phagosomes (see PMID:18045538). +-------------------------------------- +GOID: GO:0010467 +Term: gene expression +Definition: The process in which a gene's sequence is converted into a mature gene product or products (proteins or RNA). This includes the production of an RNA transcript as well as any processing to produce a mature RNA product or an mRNA (for protein-coding genes) and the translation of that mRNA into protein. Protein maturation is included when required to form an active form of a product from an inactive precursor form. +-------------------------------------- +GOID: GO:0034641 +Term: cellular nitrogen compound metabolic process +Definition: The chemical reactions and pathways involving various organic and inorganic nitrogenous compounds, as carried out by individual cells. +-------------------------------------- +GOID: GO:0044459 +Term: plasma membrane part +Definition: Any constituent part of the plasma membrane, the membrane surrounding a cell that separates the cell from its external environment. It consists of a phospholipid bilayer and associated proteins. +-------------------------------------- +GOID: GO:0044710 +Term: single-organism metabolic process +Definition: A metabolic process - chemical reactions and pathways, including anabolism and catabolism, by which living organisms transform chemical substances - which involves a single organism. +-------------------------------------- +GOID: GO:0051049 +Term: regulation of transport +Definition: Any process that modulates the frequency, rate or extent of the directed movement of substances (such as macromolecules, small molecules, ions) into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:0097159 +Term: organic cyclic compound binding +Definition: Interacting selectively and non-covalently with an organic cyclic compound, any molecular entity that contains carbon arranged in a cyclic molecular structure. +-------------------------------------- +GOID: GO:1901363 +Term: heterocyclic compound binding +Definition: Interacting selectively and non-covalently with heterocyclic compound. +-------------------------------------- +GOID: GO:0009893 +Term: positive regulation of metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways within a cell or an organism. +-------------------------------------- +GOID: GO:0009966 +Term: regulation of signal transduction +Definition: Any process that modulates the frequency, rate or extent of signal transduction. +-------------------------------------- +GOID: GO:0010033 +Term: response to organic substance +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an organic substance stimulus. +-------------------------------------- +GOID: GO:0010604 +Term: positive regulation of macromolecule metabolic process +Definition: Any process that increases the frequency, rate or extent of the chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0010646 +Term: regulation of cell communication +Definition: Any process that modulates the frequency, rate or extent of cell communication. Cell communication is the process that mediates interactions between a cell and its surroundings. Encompasses interactions such as signaling or attachment between one cell and another cell, between a cell and an extracellular matrix, or between a cell and any other aspect of its environment. +-------------------------------------- +GOID: GO:0023051 +Term: regulation of signaling +Definition: Any process that modulates the frequency, rate or extent of a signaling process. +-------------------------------------- +GOID: GO:0032991 +Term: macromolecular complex +Definition: A stable assembly of two or more macromolecules, i.e. proteins, nucleic acids, carbohydrates or lipids, in which the constituent parts function together. +-------------------------------------- +GOID: GO:0040011 +Term: locomotion +Definition: Self-propelled movement of a cell or organism from one location to another. +-------------------------------------- +GOID: GO:0048584 +Term: positive regulation of response to stimulus +Definition: Any process that activates, maintains or increases the rate of a response to a stimulus. Response to stimulus is a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. +-------------------------------------- +GOID: GO:0006915 +Term: apoptotic process +Definition: A programmed cell death process which begins when a cell receives an internal (e.g. DNA damage) or external signal (e.g. an extracellular death ligand), and proceeds through a series of biochemical events (signaling pathway phase) which trigger an execution phase. The execution phase is the last step of an apoptotic process, and is typically characterized by rounding-up of the cell, retraction of pseudopodes, reduction of cellular volume (pyknosis), chromatin condensation, nuclear fragmentation (karyorrhexis), plasma membrane blebbing and fragmentation of the cell into apoptotic bodies. When the execution phase is completed, the cell has died. +-------------------------------------- +GOID: GO:0006928 +Term: movement of cell or subcellular component +Definition: The directed, self-propelled movement of a cell or subcellular component without the involvement of an external agent such as a transporter or a pore. +-------------------------------------- +GOID: GO:0009653 +Term: anatomical structure morphogenesis +Definition: The process in which anatomical structures are generated and organized. Morphogenesis pertains to the creation of form. +-------------------------------------- +GOID: GO:0012501 +Term: programmed cell death +Definition: A process which begins when a cell receives an internal or external signal and activates a series of biochemical events (signaling pathway). The process ends with the death of the cell. +-------------------------------------- +GOID: GO:0016477 +Term: cell migration +Definition: The controlled self-propelled movement of a cell from one site to a destination guided by molecular cues. Cell migration is a central process in the development and maintenance of multicellular organisms. +-------------------------------------- +GOID: GO:0031325 +Term: positive regulation of cellular metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways by which individual cells transform chemical substances. +-------------------------------------- +GOID: GO:0048870 +Term: cell motility +Definition: Any process involved in the controlled self-propelled movement of a cell that results in translocation of the cell from one place to another. +-------------------------------------- +GOID: GO:0051246 +Term: regulation of protein metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving a protein. +-------------------------------------- +GOID: GO:0051674 +Term: localization of cell +Definition: Any process in which a cell is transported to, and/or maintained in, a specific location. +-------------------------------------- +GOID: GO:0005102 +Term: receptor binding +Definition: Interacting selectively and non-covalently with one or more specific sites on a receptor molecule, a macromolecule that undergoes combination with a hormone, neurotransmitter, drug or intracellular messenger to initiate a change in cell function. +-------------------------------------- +GOID: GO:0006464 +Term: cellular protein modification process +Definition: The covalent alteration of one or more amino acids occurring in proteins, peptides and nascent polypeptides (co-translational, post-translational modifications) occurring at the level of an individual cell. Includes the modification of charged tRNAs that are destined to occur in a protein (pre-translation modification). +-------------------------------------- +GOID: GO:0006508 +Term: proteolysis +Definition: The hydrolysis of proteins into smaller polypeptides and/or amino acids by cleavage of their peptide bonds. +-------------------------------------- +GOID: GO:0006725 +Term: cellular aromatic compound metabolic process +Definition: The chemical reactions and pathways involving aromatic compounds, any organic compound characterized by one or more planar rings, each of which contains conjugated double bonds and delocalized pi electrons, as carried out by individual cells. +-------------------------------------- +GOID: GO:0006955 +Term: immune response +Definition: Any immune system process that functions in the calibrated response of an organism to a potential internal or invasive threat. +-------------------------------------- +GOID: GO:0009059 +Term: macromolecule biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of a macromolecule, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0010468 +Term: regulation of gene expression +Definition: Any process that modulates the frequency, rate or extent of gene expression. Gene expression is the process in which a gene's coding sequence is converted into a mature gene product or products (proteins or RNA). This includes the production of an RNA transcript as well as any processing to produce a mature RNA product or an mRNA (for protein-coding genes) and the translation of that mRNA into protein. Protein maturation is included when required to form an active form of a product from an inactive precursor form. +-------------------------------------- +GOID: GO:0010941 +Term: regulation of cell death +Definition: Any process that modulates the rate or frequency of cell death. Cell death is the specific activation or halting of processes within a cell so that its vital functions markedly cease, rather than simply deteriorating gradually over time, which culminates in cell death. +-------------------------------------- +GOID: GO:0032268 +Term: regulation of cellular protein metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving a protein, occurring at the level of an individual cell. +-------------------------------------- +GOID: GO:0033036 +Term: macromolecule localization +Definition: Any process in which a macromolecule is transported to, or maintained in, a specific location. +-------------------------------------- +GOID: GO:0036211 +Term: protein modification process +Definition: The covalent alteration of one or more amino acids occurring in proteins, peptides and nascent polypeptides (co-translational, post-translational modifications). Includes the modification of charged tRNAs that are destined to occur in a protein (pre-translation modification). +-------------------------------------- +GOID: GO:0043234 +Term: protein complex +Definition: A stable macromolecular complex composed (only) of two or more polypeptide subunits along with any covalently attached molecules (such as lipid anchors or oligosaccharide) or non-protein prosthetic groups (such as nucleotides or metal ions). Prosthetic group in this context refers to a tightly bound cofactor. The component polypeptide subunits may be identical. +-------------------------------------- +GOID: GO:0043412 +Term: macromolecule modification +Definition: The covalent alteration of one or more monomeric units in a polypeptide, polynucleotide, polysaccharide, or other biological macromolecule, resulting in a change in its properties. +-------------------------------------- +GOID: GO:0044271 +Term: cellular nitrogen compound biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of organic and inorganic nitrogenous compounds. +-------------------------------------- +GOID: GO:0048513 +Term: animal organ development +Definition: Development of a tissue or tissues that work together to perform a specific function or functions. Development pertains to the process whose specific outcome is the progression of a structure over time, from its formation to the mature structure. Organs are commonly observed as visibly distinct structures, but may also exist as loosely associated clusters of cells that work together to perform a specific function or functions. +-------------------------------------- +GOID: GO:0051050 +Term: positive regulation of transport +Definition: Any process that activates or increases the frequency, rate or extent of the directed movement of substances (such as macromolecules, small molecules, ions) into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:1901360 +Term: organic cyclic compound metabolic process +Definition: The chemical reactions and pathways involving organic cyclic compound. +-------------------------------------- +GOID: GO:0005794 +Term: Golgi apparatus +Definition: A compound membranous cytoplasmic organelle of eukaryotic cells, consisting of flattened, ribosome-free vesicles arranged in a more or less regular stack. The Golgi apparatus differs from the endoplasmic reticulum in often having slightly thicker membranes, appearing in sections as a characteristic shallow semicircle so that the convex side (cis or entry face) abuts the endoplasmic reticulum, secretory vesicles emerging from the concave side (trans or exit face). In vertebrate cells there is usually one such organelle, while in invertebrates and plants, where they are known usually as dictyosomes, there may be several scattered in the cytoplasm. The Golgi apparatus processes proteins produced on the ribosomes of the rough endoplasmic reticulum; such processing includes modification of the core oligosaccharides of glycoproteins, and the sorting and packaging of proteins for transport to a variety of cellular locations. Three different regions of the Golgi are now recognized both in terms of structure and function: cis, in the vicinity of the cis face, trans, in the vicinity of the trans face, and medial, lying between the cis and trans regions. +-------------------------------------- +GOID: GO:0006954 +Term: inflammatory response +Definition: The immediate defensive reaction (by vertebrate tissue) to infection or injury caused by chemical or physical agents. The process is characterized by local vasodilation, extravasation of plasma into intercellular spaces and accumulation of white blood cells and macrophages. +-------------------------------------- +GOID: GO:0009889 +Term: regulation of biosynthetic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways resulting in the formation of substances. +-------------------------------------- +GOID: GO:0009967 +Term: positive regulation of signal transduction +Definition: Any process that activates or increases the frequency, rate or extent of signal transduction. +-------------------------------------- +GOID: GO:0010647 +Term: positive regulation of cell communication +Definition: Any process that increases the frequency, rate or extent of cell communication. Cell communication is the process that mediates interactions between a cell and its surroundings. Encompasses interactions such as signaling or attachment between one cell and another cell, between a cell and an extracellular matrix, or between a cell and any other aspect of its environment. +-------------------------------------- +GOID: GO:0016787 +Term: hydrolase activity +Definition: Catalysis of the hydrolysis of various bonds, e.g. C-O, C-N, C-C, phosphoric anhydride bonds, etc. Hydrolase is the systematic name for any enzyme of EC class 3. +-------------------------------------- +GOID: GO:0023056 +Term: positive regulation of signaling +Definition: Any process that activates, maintains or increases the frequency, rate or extent of a signaling process. +-------------------------------------- +GOID: GO:0031326 +Term: regulation of cellular biosynthetic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways resulting in the formation of substances, carried out by individual cells. +-------------------------------------- +GOID: GO:0034645 +Term: cellular macromolecule biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of a macromolecule, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass, carried out by individual cells. +-------------------------------------- +GOID: GO:0042592 +Term: homeostatic process +Definition: Any biological process involved in the maintenance of an internal steady state. +-------------------------------------- +GOID: GO:0045087 +Term: innate immune response +Definition: Innate immune responses are defense responses mediated by germline encoded components that directly recognize components of potential pathogens. +-------------------------------------- +GOID: GO:0046483 +Term: heterocycle metabolic process +Definition: The chemical reactions and pathways involving heterocyclic compounds, those with a cyclic molecular structure and at least two different atoms in the ring (or rings). +-------------------------------------- +GOID: GO:0048878 +Term: chemical homeostasis +Definition: Any biological process involved in the maintenance of an internal steady state of a chemical. +-------------------------------------- +GOID: GO:0050801 +Term: ion homeostasis +Definition: Any process involved in the maintenance of an internal steady state of ions within an organism or cell. +-------------------------------------- +GOID: GO:0051241 +Term: negative regulation of multicellular organismal process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of an organismal process, the processes pertinent to the function of an organism above the cellular level; includes the integrated processes of tissues and organs. +-------------------------------------- +GOID: GO:0055065 +Term: metal ion homeostasis +Definition: Any process involved in the maintenance of an internal steady state of metal ions within an organism or cell. +-------------------------------------- +GOID: GO:0055080 +Term: cation homeostasis +Definition: Any process involved in the maintenance of an internal steady state of cations within an organism or cell. +-------------------------------------- +GOID: GO:0071310 +Term: cellular response to organic substance +Definition: Any process that results in a change in state or activity of a cell (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an organic substance stimulus. +-------------------------------------- +GOID: GO:0098771 +Term: inorganic ion homeostasis +Definition: Any process involved in the maintenance of an internal steady state of inorganic ions within an organism or cell. +-------------------------------------- +GOID: GO:1901700 +Term: response to oxygen-containing compound +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an oxygen-containing compound stimulus. +-------------------------------------- +GOID: GO:1902531 +Term: regulation of intracellular signal transduction +Definition: Any process that modulates the frequency, rate or extent of intracellular signal transduction. +-------------------------------------- +GOID: GO:0006139 +Term: nucleobase-containing compound metabolic process +Definition: Any cellular metabolic process involving nucleobases, nucleosides, nucleotides and nucleic acids. +-------------------------------------- +GOID: GO:0006793 +Term: phosphorus metabolic process +Definition: The chemical reactions and pathways involving the nonmetallic element phosphorus or compounds that contain phosphorus, usually in the form of a phosphate group (PO4). +-------------------------------------- +GOID: GO:0006796 +Term: phosphate-containing compound metabolic process +Definition: The chemical reactions and pathways involving the phosphate group, the anion or salt of any phosphoric acid. +-------------------------------------- +GOID: GO:0006811 +Term: ion transport +Definition: The directed movement of charged atoms or small charged molecules into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:0007155 +Term: cell adhesion +Definition: The attachment of a cell, either to another cell or to an underlying substrate such as the extracellular matrix, via cell adhesion molecules. +-------------------------------------- +GOID: GO:0007166 +Term: cell surface receptor signaling pathway +Definition: A series of molecular signals initiated by activation of a receptor on the surface of a cell. The pathway begins with binding of an extracellular ligand to a cell surface receptor, or for receptors that signal in the absence of a ligand, by ligand-withdrawal or the activity of a constitutively active receptor. The pathway ends with regulation of a downstream cellular process, e.g. transcription. +-------------------------------------- +GOID: GO:0008283 +Term: cell proliferation +Definition: The multiplication or reproduction of cells, resulting in the expansion of a cell population. +-------------------------------------- +GOID: GO:0010556 +Term: regulation of macromolecule biosynthetic process +Definition: Any process that modulates the rate, frequency or extent of the chemical reactions and pathways resulting in the formation of a macromolecule, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0016070 +Term: RNA metabolic process +Definition: The cellular chemical reactions and pathways involving RNA, ribonucleic acid, one of the two main type of nucleic acid, consisting of a long, unbranched macromolecule formed from ribonucleotides joined in 3',5'-phosphodiester linkage. +-------------------------------------- +GOID: GO:0016310 +Term: phosphorylation +Definition: The process of introducing a phosphate group into a molecule, usually with the formation of a phosphoric ester, a phosphoric anhydride or a phosphoric amide. +-------------------------------------- +GOID: GO:0022610 +Term: biological adhesion +Definition: The attachment of a cell or organism to a substrate, another cell, or other organism. Biological adhesion includes intracellular attachment between membrane regions. +-------------------------------------- +GOID: GO:0032101 +Term: regulation of response to external stimulus +Definition: Any process that modulates the frequency, rate or extent of a response to an external stimulus. +-------------------------------------- +GOID: GO:0042981 +Term: regulation of apoptotic process +Definition: Any process that modulates the occurrence or rate of cell death by apoptotic process. +-------------------------------------- +GOID: GO:0043067 +Term: regulation of programmed cell death +Definition: Any process that modulates the frequency, rate or extent of programmed cell death, cell death resulting from activation of endogenous cellular processes. +-------------------------------------- +GOID: GO:0046914 +Term: transition metal ion binding +Definition: Interacting selectively and non-covalently with a transition metal ions; a transition metal is an element whose atom has an incomplete d-subshell of extranuclear electrons, or which gives rise to a cation or cations with an incomplete d-subshell. Transition metals often have more than one valency state. Biologically relevant transition metals include vanadium, manganese, iron, copper, cobalt, nickel, molybdenum and silver. +-------------------------------------- +GOID: GO:0050793 +Term: regulation of developmental process +Definition: Any process that modulates the frequency, rate or extent of development, the biological process whose specific outcome is the progression of a multicellular organism over time from an initial condition (e.g. a zygote, or a young adult) to a later condition (e.g. a multicellular animal or an aged adult). +-------------------------------------- +GOID: GO:0051128 +Term: regulation of cellular component organization +Definition: Any process that modulates the frequency, rate or extent of a process involved in the formation, arrangement of constituent parts, or disassembly of cell structures, including the plasma membrane and any external encapsulating structures such as the cell wall and cell envelope. +-------------------------------------- +GOID: GO:0051247 +Term: positive regulation of protein metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways involving a protein. +-------------------------------------- +GOID: GO:0065009 +Term: regulation of molecular function +Definition: Any process that modulates the frequency, rate or extent of a molecular function, an elemental biological activity occurring at the molecular level, such as catalysis or binding. +-------------------------------------- +GOID: GO:0080134 +Term: regulation of response to stress +Definition: Any process that modulates the frequency, rate or extent of a response to stress. Response to stress is a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a disturbance in organismal or cellular homeostasis, usually, but not necessarily, exogenous (e.g. temperature, humidity, ionizing radiation). +-------------------------------------- +GOID: GO:0090304 +Term: nucleic acid metabolic process +Definition: Any cellular metabolic process involving nucleic acids. +-------------------------------------- +GOID: GO:0002682 +Term: regulation of immune system process +Definition: Any process that modulates the frequency, rate, or extent of an immune system process. +-------------------------------------- +GOID: GO:0004871 +Term: signal transducer activity +Definition: Conveys a signal across a cell to trigger a change in cell function or state. A signal is a physical entity or change in state that is used to transfer information in order to trigger a response. +-------------------------------------- +GOID: GO:0006351 +Term: transcription, DNA-templated +Definition: The cellular synthesis of RNA on a template of DNA. +-------------------------------------- +GOID: GO:0006468 +Term: protein phosphorylation +Definition: The process of introducing a phosphate group on to a protein. +-------------------------------------- +GOID: GO:0006935 +Term: chemotaxis +Definition: The directed movement of a motile cell or organism, or the directed growth of a cell guided by a specific chemical concentration gradient. Movement may be towards a higher concentration (positive chemotaxis) or towards a lower concentration (negative chemotaxis). +-------------------------------------- +GOID: GO:0008104 +Term: protein localization +Definition: Any process in which a protein is transported to, or maintained in, a specific location. +-------------------------------------- +GOID: GO:0009892 +Term: negative regulation of metabolic process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of the chemical reactions and pathways within a cell or an organism. +-------------------------------------- +GOID: GO:0010628 +Term: positive regulation of gene expression +Definition: Any process that increases the frequency, rate or extent of gene expression. Gene expression is the process in which a gene's coding sequence is converted into a mature gene product or products (proteins or RNA). This includes the production of an RNA transcript as well as any processing to produce a mature RNA product or an mRNA (for protein-coding genes) and the translation of that mRNA into protein. Protein maturation is included when required to form an active form of a product from an inactive precursor form. +-------------------------------------- +GOID: GO:0015031 +Term: protein transport +Definition: The directed movement of proteins into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:0018130 +Term: heterocycle biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of heterocyclic compounds, those with a cyclic molecular structure and at least two different atoms in the ring (or rings). +-------------------------------------- +GOID: GO:0019438 +Term: aromatic compound biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of aromatic compounds, any substance containing an aromatic carbon ring. +-------------------------------------- +GOID: GO:0031226 +Term: intrinsic component of plasma membrane +Definition: The component of the plasma membrane consisting of the gene products and protein complexes having either part of their peptide sequence embedded in the hydrophobic region of the membrane or some other covalently attached group such as a GPI anchor that is similarly embedded in the membrane. +-------------------------------------- +GOID: GO:0032270 +Term: positive regulation of cellular protein metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways involving a protein, occurring at the level of an individual cell. +-------------------------------------- +GOID: GO:0032774 +Term: RNA biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of RNA, ribonucleic acid, one of the two main type of nucleic acid, consisting of a long, unbranched macromolecule formed from ribonucleotides joined in 3',5'-phosphodiester linkage. Includes polymerization of ribonucleotide monomers. Refers not only to transcription but also to e.g. viral RNA replication. +-------------------------------------- +GOID: GO:0034654 +Term: nucleobase-containing compound biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of nucleobases, nucleosides, nucleotides and nucleic acids. +-------------------------------------- +GOID: GO:0042330 +Term: taxis +Definition: The directed movement of a motile cell or organism in response to an external stimulus. +-------------------------------------- +GOID: GO:0043228 +Term: non-membrane-bounded organelle +Definition: Organized structure of distinctive morphology and function, not bounded by a lipid bilayer membrane. Includes ribosomes, the cytoskeleton and chromosomes. +-------------------------------------- +GOID: GO:0043232 +Term: intracellular non-membrane-bounded organelle +Definition: Organized structure of distinctive morphology and function, not bounded by a lipid bilayer membrane and occurring within the cell. Includes ribosomes, the cytoskeleton and chromosomes. +-------------------------------------- +GOID: GO:0045184 +Term: establishment of protein localization +Definition: The directed movement of a protein to a specific location. +-------------------------------------- +GOID: GO:0045595 +Term: regulation of cell differentiation +Definition: Any process that modulates the frequency, rate or extent of cell differentiation, the process in which relatively unspecialized cells acquire specialized structural and functional features. +-------------------------------------- +GOID: GO:0048468 +Term: cell development +Definition: The process whose specific outcome is the progression of the cell over time, from its formation to the mature structure. Cell development does not include the steps involved in committing a cell to a specific fate. +-------------------------------------- +GOID: GO:0050790 +Term: regulation of catalytic activity +Definition: Any process that modulates the activity of an enzyme. +-------------------------------------- +GOID: GO:0051171 +Term: regulation of nitrogen compound metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving nitrogen or nitrogenous compounds. +-------------------------------------- +GOID: GO:0097367 +Term: carbohydrate derivative binding +Definition: Interacting selectively and non-covalently with a carbohydrate derivative. +-------------------------------------- +GOID: GO:0097659 +Term: nucleic acid-templated transcription +Definition: The cellular synthesis of RNA on a template of nucleic acid (DNA or RNA). +-------------------------------------- +GOID: GO:1901362 +Term: organic cyclic compound biosynthetic process +Definition: The chemical reactions and pathways resulting in the formation of organic cyclic compound. +-------------------------------------- +GOID: GO:1902533 +Term: positive regulation of intracellular signal transduction +Definition: Any process that activates or increases the frequency, rate or extent of intracellular signal transduction. +-------------------------------------- +GOID: GO:2000112 +Term: regulation of cellular macromolecule biosynthetic process +Definition: Any process that modulates the frequency, rate or extent of cellular macromolecule biosynthetic process. +-------------------------------------- +GOID: GO:0001816 +Term: cytokine production +Definition: The appearance of a cytokine due to biosynthesis or secretion following a cellular stimulus, resulting in an increase in its intracellular or extracellular levels. +-------------------------------------- +GOID: GO:0001817 +Term: regulation of cytokine production +Definition: Any process that modulates the frequency, rate, or extent of production of a cytokine. +-------------------------------------- +GOID: GO:0002252 +Term: immune effector process +Definition: Any process of the immune system that can potentially contribute to an immune response. +-------------------------------------- +GOID: GO:0003676 +Term: nucleic acid binding +Definition: Interacting selectively and non-covalently with any nucleic acid. +-------------------------------------- +GOID: GO:0005773 +Term: vacuole +Definition: A closed structure, found only in eukaryotic cells, that is completely surrounded by unit membrane and contains liquid material. Cells contain one or several vacuoles, that may have different functions from each other. Vacuoles have a diverse array of functions. They can act as a storage organelle for nutrients or waste products, as a degradative compartment, as a cost-effective way of increasing cell size, and as a homeostatic regulator controlling both turgor pressure and pH of the cytosol. +-------------------------------------- +GOID: GO:0005783 +Term: endoplasmic reticulum +Definition: The irregular network of unit membranes, visible only by electron microscopy, that occurs in the cytoplasm of many eukaryotic cells. The membranes form a complex meshwork of tubular channels, which are often expanded into slitlike cavities called cisternae. The ER takes two forms, rough (or granular), with ribosomes adhering to the outer surface, and smooth (with no ribosomes attached). +-------------------------------------- +GOID: GO:0006355 +Term: regulation of transcription, DNA-templated +Definition: Any process that modulates the frequency, rate or extent of cellular DNA-templated transcription. +-------------------------------------- +GOID: GO:0006629 +Term: lipid metabolic process +Definition: The chemical reactions and pathways involving lipids, compounds soluble in an organic solvent but not, or sparingly, in an aqueous solvent. Includes fatty acids; neutral fats, other fatty-acid esters, and soaps; long-chain (fatty) alcohols and waxes; sphingoids and other long-chain bases; glycolipids, phospholipids and sphingolipids; and carotenes, polyprenols, sterols, terpenes and other isoprenoids. +-------------------------------------- +GOID: GO:0006873 +Term: cellular ion homeostasis +Definition: Any process involved in the maintenance of an internal steady state of ions at the level of a cell. +-------------------------------------- +GOID: GO:0006875 +Term: cellular metal ion homeostasis +Definition: Any process involved in the maintenance of an internal steady state of metal ions at the level of a cell. +-------------------------------------- +GOID: GO:0008270 +Term: zinc ion binding +Definition: Interacting selectively and non-covalently with zinc (Zn) ions. +-------------------------------------- +GOID: GO:0008289 +Term: lipid binding +Definition: Interacting selectively and non-covalently with a lipid. +-------------------------------------- +GOID: GO:0009607 +Term: response to biotic stimulus +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a biotic stimulus, a stimulus caused or produced by a living organism. +-------------------------------------- +GOID: GO:0009888 +Term: tissue development +Definition: The process whose specific outcome is the progression of a tissue over time, from its formation to the mature structure. +-------------------------------------- +GOID: GO:0010605 +Term: negative regulation of macromolecule metabolic process +Definition: Any process that decreases the frequency, rate or extent of the chemical reactions and pathways involving macromolecules, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0018193 +Term: peptidyl-amino acid modification +Definition: The alteration of an amino acid residue in a peptide. +-------------------------------------- +GOID: GO:0019219 +Term: regulation of nucleobase-containing compound metabolic process +Definition: Any cellular process that modulates the frequency, rate or extent of the chemical reactions and pathways involving nucleobases, nucleosides, nucleotides and nucleic acids. +-------------------------------------- +GOID: GO:0019725 +Term: cellular homeostasis +Definition: Any process involved in the maintenance of an internal steady state at the level of the cell. +-------------------------------------- +GOID: GO:0030003 +Term: cellular cation homeostasis +Definition: Any process involved in the maintenance of an internal steady state of cations at the level of a cell. +-------------------------------------- +GOID: GO:0031090 +Term: organelle membrane +Definition: A membrane that is one of the two lipid bilayers of an organelle envelope or the outermost membrane of single membrane bound organelle. +-------------------------------------- +GOID: GO:0031324 +Term: negative regulation of cellular metabolic process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of the chemical reactions and pathways by which individual cells transform chemical substances. +-------------------------------------- +GOID: GO:0031347 +Term: regulation of defense response +Definition: Any process that modulates the frequency, rate or extent of a defense response. +-------------------------------------- +GOID: GO:0031349 +Term: positive regulation of defense response +Definition: Any process that activates or increases the frequency, rate or extent of a defense response. +-------------------------------------- +GOID: GO:0031974 +Term: membrane-enclosed lumen +Definition: The enclosed volume within a sealed membrane or between two sealed membranes. Encompasses the volume enclosed by the membranes of a particular organelle, e.g. endoplasmic reticulum lumen, or the space between the two lipid bilayers of a double membrane surrounding an organelle, e.g. nuclear envelope lumen. +-------------------------------------- +GOID: GO:0032103 +Term: positive regulation of response to external stimulus +Definition: Any process that activates, maintains or increases the rate of a response to an external stimulus. +-------------------------------------- +GOID: GO:0036094 +Term: small molecule binding +Definition: Interacting selectively and non-covalently with a small molecule, any low molecular weight, monomeric, non-encoded molecule. +-------------------------------------- +GOID: GO:0042127 +Term: regulation of cell proliferation +Definition: Any process that modulates the frequency, rate or extent of cell proliferation. +-------------------------------------- +GOID: GO:0043207 +Term: response to external biotic stimulus +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an external biotic stimulus, an external stimulus caused by, or produced by living things. +-------------------------------------- +GOID: GO:0043233 +Term: organelle lumen +Definition: The internal volume enclosed by the membranes of a particular organelle; includes the volume enclosed by a single organelle membrane, e.g. endoplasmic reticulum lumen, or the volume enclosed by the innermost of the two lipid bilayers of an organelle envelope, e.g. nuclear lumen. +-------------------------------------- +GOID: GO:0044085 +Term: cellular component biogenesis +Definition: A process that results in the biosynthesis of constituent macromolecules, assembly, and arrangement of constituent parts of a cellular component. Includes biosynthesis of constituent macromolecules, and those macromolecular modifications that are involved in synthesis or assembly of the cellular component. +-------------------------------------- +GOID: GO:0044428 +Term: nuclear part +Definition: Any constituent part of the nucleus, a membrane-bounded organelle of eukaryotic cells in which chromosomes are housed and replicated. +-------------------------------------- +GOID: GO:0046903 +Term: secretion +Definition: The controlled release of a substance by a cell or a tissue. +-------------------------------------- +GOID: GO:0048585 +Term: negative regulation of response to stimulus +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of a response to a stimulus. Response to stimulus is a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus. +-------------------------------------- +GOID: GO:0048646 +Term: anatomical structure formation involved in morphogenesis +Definition: The developmental process pertaining to the initial formation of an anatomical structure from unspecified parts. This process begins with the specific processes that contribute to the appearance of the discrete structure and ends when the structural rudiment is recognizable. An anatomical structure is any biological entity that occupies space and is distinguished from its surroundings. Anatomical structures can be macroscopic such as a carpel, or microscopic such as an acrosome. +-------------------------------------- +GOID: GO:0051240 +Term: positive regulation of multicellular organismal process +Definition: Any process that activates or increases the frequency, rate or extent of an organismal process, any of the processes pertinent to the function of an organism above the cellular level; includes the integrated processes of tissues and organs. +-------------------------------------- +GOID: GO:0051252 +Term: regulation of RNA metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving RNA. +-------------------------------------- +GOID: GO:0051641 +Term: cellular localization +Definition: A localization process that takes place at the cellular level; as a result of a cellular localization process, a substance or cellular entity, such as a protein complex or organelle, is transported to, and/or maintained in, a specific location within or in the membrane of a cell. +-------------------------------------- +GOID: GO:0051704 +Term: multi-organism process +Definition: A biological process which involves another organism of the same or different species. +-------------------------------------- +GOID: GO:0051707 +Term: response to other organism +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus from another living organism. +-------------------------------------- +GOID: GO:0055082 +Term: cellular chemical homeostasis +Definition: Any biological process involved in the maintenance of an internal steady state of a chemical at the level of the cell. +-------------------------------------- +GOID: GO:0060326 +Term: cell chemotaxis +Definition: The directed movement of a motile cell guided by a specific chemical concentration gradient. Movement may be towards a higher concentration (positive chemotaxis) or towards a lower concentration (negative chemotaxis). +-------------------------------------- +GOID: GO:0098588 +Term: bounding membrane of organelle +Definition: The lipid bilayer that forms the outer-most layer of an organelle. +-------------------------------------- +GOID: GO:1901564 +Term: organonitrogen compound metabolic process +Definition: The chemical reactions and pathways involving organonitrogen compound. +-------------------------------------- +GOID: GO:1903506 +Term: regulation of nucleic acid-templated transcription +Definition: Any process that modulates the frequency, rate or extent of nucleic acid-templated transcription. +-------------------------------------- +GOID: GO:2000026 +Term: regulation of multicellular organismal development +Definition: Any process that modulates the frequency, rate or extent of multicellular organismal development. +-------------------------------------- +GOID: GO:2001141 +Term: regulation of RNA biosynthetic process +Definition: Any process that modulates the frequency, rate or extent of RNA biosynthetic process. +-------------------------------------- +GOID: GO:0000166 +Term: nucleotide binding +Definition: Interacting selectively and non-covalently with a nucleotide, any compound consisting of a nucleoside that is esterified with (ortho)phosphate or an oligophosphate at any hydroxyl group on the ribose or deoxyribose. +-------------------------------------- +GOID: GO:0002684 +Term: positive regulation of immune system process +Definition: Any process that activates or increases the frequency, rate, or extent of an immune system process. +-------------------------------------- +GOID: GO:0004872 +Term: receptor activity +Definition: Combining with an extracellular or intracellular messenger to initiate a change in cell activity. +-------------------------------------- +GOID: GO:0004888 +Term: transmembrane signaling receptor activity +Definition: Combining with an extracellular or intracellular signal and transmitting the signal from one side of the membrane to the other to initiate a change in cell activity or state as part of signal transduction. +-------------------------------------- +GOID: GO:0005215 +Term: transporter activity +Definition: Enables the directed movement of substances (such as macromolecules, small molecules, ions) into, out of or within a cell, or between cells. +-------------------------------------- +GOID: GO:0005856 +Term: cytoskeleton +Definition: Any of the various filamentous elements that form the internal framework of cells, and typically remain after treatment of the cells with mild detergent to remove membrane constituents and soluble components of the cytoplasm. The term embraces intermediate filaments, microfilaments, microtubules, the microtrabecular lattice, and other structures characterized by a polymeric filamentous nature and long-range order within the cell. The various elements of the cytoskeleton not only serve in the maintenance of cellular shape but also have roles in other cellular functions, including cellular movement, cell division, endocytosis, and movement of organelles. +-------------------------------------- +GOID: GO:0005887 +Term: integral component of plasma membrane +Definition: The component of the plasma membrane consisting of the gene products and protein complexes having at least some part of their peptide sequence embedded in the hydrophobic region of the membrane. +-------------------------------------- +GOID: GO:0006812 +Term: cation transport +Definition: The directed movement of cations, atoms or small molecules with a net positive charge, into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:0009891 +Term: positive regulation of biosynthetic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways resulting in the formation of substances. +-------------------------------------- +GOID: GO:0010256 +Term: endomembrane system organization +Definition: A process that is carried out at the cellular level which results in the assembly, arrangement of constituent parts, or disassembly of the endomembrane system. +-------------------------------------- +GOID: GO:0010557 +Term: positive regulation of macromolecule biosynthetic process +Definition: Any process that increases the rate, frequency or extent of the chemical reactions and pathways resulting in the formation of a macromolecule, any molecule of high relative molecular mass, the structure of which essentially comprises the multiple repetition of units derived, actually or conceptually, from molecules of low relative molecular mass. +-------------------------------------- +GOID: GO:0010942 +Term: positive regulation of cell death +Definition: Any process that increases the rate or frequency of cell death. Cell death is the specific activation or halting of processes within a cell so that its vital functions markedly cease, rather than simply deteriorating gradually over time, which culminates in cell death. +-------------------------------------- +GOID: GO:0016192 +Term: vesicle-mediated transport +Definition: A cellular transport process in which transported substances are moved in membrane-bounded vesicles; transported substances are enclosed in the vesicle lumen or located in the vesicle membrane. The process begins with a step that directs a substance to the forming vesicle, and includes vesicle budding and coating. Vesicles are then targeted to, and fuse with, an acceptor membrane. +-------------------------------------- +GOID: GO:0019899 +Term: enzyme binding +Definition: Interacting selectively and non-covalently with any enzyme. +-------------------------------------- +GOID: GO:0022607 +Term: cellular component assembly +Definition: The aggregation, arrangement and bonding together of a cellular component. +-------------------------------------- +GOID: GO:0030001 +Term: metal ion transport +Definition: The directed movement of metal ions, any metal ion with an electric charge, into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:0030162 +Term: regulation of proteolysis +Definition: Any process that modulates the frequency, rate or extent of the hydrolysis of a peptide bond or bonds within a protein. +-------------------------------------- +GOID: GO:0031328 +Term: positive regulation of cellular biosynthetic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways resulting in the formation of substances, carried out by individual cells. +-------------------------------------- +GOID: GO:0031981 +Term: nuclear lumen +Definition: The volume enclosed by the nuclear inner membrane. +-------------------------------------- +GOID: GO:0032880 +Term: regulation of protein localization +Definition: Any process that modulates the frequency, rate or extent of any process in which a protein is transported to, or maintained in, a specific location. +-------------------------------------- +GOID: GO:0034613 +Term: cellular protein localization +Definition: Any process in which a protein is transported to, and/or maintained in, a specific location at the level of a cell. Localization at the cellular level encompasses movement within the cell, from within the cell to the cell surface, or from one location to another at the surface of a cell. +-------------------------------------- +GOID: GO:0038023 +Term: signaling receptor activity +Definition: Receiving a signal and transmitting the signal in the cell to initiate a change in cell activity. A signal is a physical entity or change in state that is used to transfer information in order to trigger a response. +-------------------------------------- +GOID: GO:0040007 +Term: growth +Definition: The increase in size or mass of an entire organism, a part of an organism or a cell. +-------------------------------------- +GOID: GO:0044281 +Term: small molecule metabolic process +Definition: The chemical reactions and pathways involving small molecules, any low molecular weight, monomeric, non-encoded molecule. +-------------------------------------- +GOID: GO:0050727 +Term: regulation of inflammatory response +Definition: Any process that modulates the frequency, rate or extent of the inflammatory response, the immediate defensive reaction (by vertebrate tissue) to infection or injury caused by chemical or physical agents. +-------------------------------------- +GOID: GO:0050729 +Term: positive regulation of inflammatory response +Definition: Any process that activates or increases the frequency, rate or extent of the inflammatory response. +-------------------------------------- +GOID: GO:0050776 +Term: regulation of immune response +Definition: Any process that modulates the frequency, rate or extent of the immune response, the immunological reaction of an organism to an immunogenic stimulus. +-------------------------------------- +GOID: GO:0050778 +Term: positive regulation of immune response +Definition: Any process that activates or increases the frequency, rate or extent of the immune response, the immunological reaction of an organism to an immunogenic stimulus. +-------------------------------------- +GOID: GO:0051046 +Term: regulation of secretion +Definition: Any process that modulates the frequency, rate or extent of the controlled release of a substance from a cell or a tissue. +-------------------------------------- +GOID: GO:0051336 +Term: regulation of hydrolase activity +Definition: Any process that modulates the frequency, rate or extent of hydrolase activity, the catalysis of the hydrolysis of various bonds, e.g. C-O, C-N, C-C, phosphoric anhydride bonds, etc. Hydrolase is the systematic name for any enzyme of EC class 3. +-------------------------------------- +GOID: GO:0055076 +Term: transition metal ion homeostasis +Definition: Any process involved in the maintenance of an internal steady state of transition metal ions within an organism or cell. A transition metal is an element whose atom has an incomplete d-subshell of extranuclear electrons, or which gives rise to a cation or cations with an incomplete d-subshell. Transition metals often have more than one valency state. Biologically relevant transition metals include vanadium, manganese, iron, copper, cobalt, nickel, molybdenum and silver. +-------------------------------------- +GOID: GO:0060089 +Term: molecular transducer activity +Definition: The molecular function that accepts an input of one form and creates an output of a different form. +-------------------------------------- +GOID: GO:0061024 +Term: membrane organization +Definition: A process which results in the assembly, arrangement of constituent parts, or disassembly of a membrane. A membrane is a double layer of lipid molecules that encloses all cells, and, in eukaryotes, many organelles; may be a single or double lipid bilayer; also includes associated proteins. +-------------------------------------- +GOID: GO:0070013 +Term: intracellular organelle lumen +Definition: An organelle lumen that is part of an intracellular organelle. +-------------------------------------- +GOID: GO:0070201 +Term: regulation of establishment of protein localization +Definition: Any process that modulates the frequency, rate or extent of the directed movement of a protein to a specific location. +-------------------------------------- +GOID: GO:0070727 +Term: cellular macromolecule localization +Definition: Any process in which a macromolecule is transported to, and/or maintained in, a specific location at the level of a cell. Localization at the cellular level encompasses movement within the cell, from within the cell to the cell surface, or from one location to another at the surface of a cell. +-------------------------------------- +GOID: GO:0072562 +Term: blood microparticle +Definition: A phospholipid microvesicle that is derived from any of several cell types, such as platelets, blood cells, endothelial cells, or others, and contains membrane receptors as well as other proteins characteristic of the parental cell. Microparticles are heterogeneous in size, and are characterized as microvesicles free of nucleic acids. +-------------------------------------- +GOID: GO:0097190 +Term: apoptotic signaling pathway +Definition: A series of molecular signals which triggers the apoptotic death of a cell. The pathway starts with reception of a signal, and ends when the execution phase of apoptosis is triggered. +-------------------------------------- +GOID: GO:0098805 +Term: whole membrane +Definition: Any lipid bilayer that completely encloses some structure, and all the proteins embedded in it or attached to it. Examples include the plasma membrane and most organelle membranes. +-------------------------------------- +GOID: GO:0099600 +Term: transmembrane receptor activity +Definition: Combining with an extracellular or intracellular signal and transmitting a signal from one side of the membrane to the other. +-------------------------------------- +GOID: GO:1901265 +Term: nucleoside phosphate binding +Definition: Interacting selectively and non-covalently with nucleoside phosphate. +-------------------------------------- +GOID: GO:1901701 +Term: cellular response to oxygen-containing compound +Definition: Any process that results in a change in state or activity of a cell (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an oxygen-containing compound stimulus. +-------------------------------------- +GOID: GO:0000323 +Term: lytic vacuole +Definition: A vacuole that is maintained at an acidic pH and which contains degradative enzymes, including a wide variety of acid hydrolases. +-------------------------------------- +GOID: GO:0001525 +Term: angiogenesis +Definition: Blood vessel formation when new vessels emerge from the proliferation of pre-existing blood vessels. +-------------------------------------- +GOID: GO:0001568 +Term: blood vessel development +Definition: The process whose specific outcome is the progression of a blood vessel over time, from its formation to the mature structure. The blood vessel is the vasculature carrying blood. +-------------------------------------- +GOID: GO:0001882 +Term: nucleoside binding +Definition: Interacting selectively and non-covalently with a nucleoside, a compound consisting of a purine or pyrimidine nitrogenous base linked either to ribose or deoxyribose. +-------------------------------------- +GOID: GO:0001883 +Term: purine nucleoside binding +Definition: Interacting selectively and non-covalently with a purine nucleoside, a compound consisting of a purine base linked either to ribose or deoxyribose. +-------------------------------------- +GOID: GO:0001932 +Term: regulation of protein phosphorylation +Definition: Any process that modulates the frequency, rate or extent of addition of phosphate groups into an amino acid in a protein. +-------------------------------------- +GOID: GO:0001944 +Term: vasculature development +Definition: The process whose specific outcome is the progression of the vasculature over time, from its formation to the mature structure. The vasculature is an interconnected tubular multi-tissue structure that contains fluid that is actively transported around the organism. +-------------------------------------- +GOID: GO:0002526 +Term: acute inflammatory response +Definition: Inflammation which comprises a rapid, short-lived, relatively uniform response to acute injury or antigenic challenge and is characterized by accumulations of fluid, plasma proteins, and granulocytic leukocytes. An acute inflammatory response occurs within a matter of minutes or hours, and either resolves within a few days or becomes a chronic inflammatory response. +-------------------------------------- +GOID: GO:0003008 +Term: system process +Definition: A multicellular organismal process carried out by any of the organs or tissues in an organ system. An organ system is a regularly interacting or interdependent group of organs or tissues that work together to carry out a biological objective. +-------------------------------------- +GOID: GO:0005524 +Term: ATP binding +Definition: Interacting selectively and non-covalently with ATP, adenosine 5'-triphosphate, a universally important coenzyme and enzyme regulator. +-------------------------------------- +GOID: GO:0005654 +Term: nucleoplasm +Definition: That part of the nuclear content other than the chromosomes or the nucleolus. +-------------------------------------- +GOID: GO:0005764 +Term: lysosome +Definition: A small lytic vacuole that has cell cycle-independent morphology and is found in most animal cells and that contains a variety of hydrolases, most of which have their maximal activities in the pH range 5-6. The contained enzymes display latency if properly isolated. About 40 different lysosomal hydrolases are known and lysosomes have a great variety of morphologies and functions. +-------------------------------------- +GOID: GO:0005829 +Term: cytosol +Definition: The part of the cytoplasm that does not contain organelles but which does contain other particulate matter, such as protein complexes. +-------------------------------------- +GOID: GO:0006357 +Term: regulation of transcription from RNA polymerase II promoter +Definition: Any process that modulates the frequency, rate or extent of transcription from an RNA polymerase II promoter. +-------------------------------------- +GOID: GO:0006366 +Term: transcription from RNA polymerase II promoter +Definition: The synthesis of RNA from a DNA template by RNA polymerase II, originating at an RNA polymerase II promoter. Includes transcription of messenger RNA (mRNA) and certain small nuclear RNAs (snRNAs). +-------------------------------------- +GOID: GO:0008284 +Term: positive regulation of cell proliferation +Definition: Any process that activates or increases the rate or extent of cell proliferation. +-------------------------------------- +GOID: GO:0009056 +Term: catabolic process +Definition: The chemical reactions and pathways resulting in the breakdown of substances, including the breakdown of carbon compounds with the liberation of energy for use by the cell or organism. +-------------------------------------- +GOID: GO:0010035 +Term: response to inorganic substance +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of an inorganic substance stimulus. +-------------------------------------- +GOID: GO:0010562 +Term: positive regulation of phosphorus metabolic process +Definition: Any process that increases the frequency, rate or extent of the chemical reactions and pathways involving phosphorus or compounds containing phosphorus. +-------------------------------------- +GOID: GO:0016740 +Term: transferase activity +Definition: Catalysis of the transfer of a group, e.g. a methyl group, glycosyl group, acyl group, phosphorus-containing, or other groups, from one compound (generally regarded as the donor) to another compound (generally regarded as the acceptor). Transferase is the systematic name for any enzyme of EC class 2. +-------------------------------------- +GOID: GO:0017076 +Term: purine nucleotide binding +Definition: Interacting selectively and non-covalently with purine nucleotides, any compound consisting of a purine nucleoside esterified with (ortho)phosphate. +-------------------------------------- +GOID: GO:0019220 +Term: regulation of phosphate metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving phosphates. +-------------------------------------- +GOID: GO:0030554 +Term: adenyl nucleotide binding +Definition: Interacting selectively and non-covalently with adenyl nucleotides, any compound consisting of adenosine esterified with (ortho)phosphate. +-------------------------------------- +GOID: GO:0030855 +Term: epithelial cell differentiation +Definition: The process in which a relatively unspecialized cell acquires specialized features of an epithelial cell, any of the cells making up an epithelium. +-------------------------------------- +GOID: GO:0031399 +Term: regulation of protein modification process +Definition: Any process that modulates the frequency, rate or extent of the covalent alteration of one or more amino acid residues within a protein. +-------------------------------------- +GOID: GO:0031401 +Term: positive regulation of protein modification process +Definition: Any process that activates or increases the frequency, rate or extent of the covalent alteration of one or more amino acid residues within a protein. +-------------------------------------- +GOID: GO:0032549 +Term: ribonucleoside binding +Definition: Interacting selectively and non-covalently with a ribonucleoside, a compound consisting of a purine or pyrimidine nitrogenous base linked to ribose. +-------------------------------------- +GOID: GO:0032550 +Term: purine ribonucleoside binding +Definition: Interacting selectively and non-covalently with a purine ribonucleoside, a compound consisting of a purine base linked to ribose. +-------------------------------------- +GOID: GO:0032553 +Term: ribonucleotide binding +Definition: Interacting selectively and non-covalently with a ribonucleotide, any compound consisting of a ribonucleoside that is esterified with (ortho)phosphate or an oligophosphate at any hydroxyl group on the ribose moiety. +-------------------------------------- +GOID: GO:0032555 +Term: purine ribonucleotide binding +Definition: Interacting selectively and non-covalently with a purine ribonucleotide, any compound consisting of a purine ribonucleoside that is esterified with (ortho)phosphate or an oligophosphate at any hydroxyl group on the ribose moiety. +-------------------------------------- +GOID: GO:0032559 +Term: adenyl ribonucleotide binding +Definition: Interacting selectively and non-covalently with an adenyl ribonucleotide, any compound consisting of adenosine esterified with (ortho)phosphate or an oligophosphate at any hydroxyl group on the ribose moiety. +-------------------------------------- +GOID: GO:0034097 +Term: response to cytokine +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a cytokine stimulus. +-------------------------------------- +GOID: GO:0035639 +Term: purine ribonucleoside triphosphate binding +Definition: Interacting selectively and non-covalently with a purine ribonucleoside triphosphate, a compound consisting of a purine base linked to a ribose sugar esterified with triphosphate on the sugar. +-------------------------------------- +GOID: GO:0042325 +Term: regulation of phosphorylation +Definition: Any process that modulates the frequency, rate or extent of addition of phosphate groups into a molecule. +-------------------------------------- +GOID: GO:0042802 +Term: identical protein binding +Definition: Interacting selectively and non-covalently with an identical protein or proteins. +-------------------------------------- +GOID: GO:0042995 +Term: cell projection +Definition: A prolongation or process extending from a cell, e.g. a flagellum or axon. +-------------------------------------- +GOID: GO:0043065 +Term: positive regulation of apoptotic process +Definition: Any process that activates or increases the frequency, rate or extent of cell death by apoptotic process. +-------------------------------------- +GOID: GO:0043068 +Term: positive regulation of programmed cell death +Definition: Any process that activates or increases the frequency, rate or extent of programmed cell death, cell death resulting from activation of endogenous cellular processes. +-------------------------------------- +GOID: GO:0044255 +Term: cellular lipid metabolic process +Definition: The chemical reactions and pathways involving lipids, as carried out by individual cells. +-------------------------------------- +GOID: GO:0044877 +Term: macromolecular complex binding +Definition: Interacting selectively and non-covalently with any macromolecular complex. +-------------------------------------- +GOID: GO:0045893 +Term: positive regulation of transcription, DNA-templated +Definition: Any process that activates or increases the frequency, rate or extent of cellular DNA-templated transcription. +-------------------------------------- +GOID: GO:0045935 +Term: positive regulation of nucleobase-containing compound metabolic process +Definition: Any cellular process that activates or increases the frequency, rate or extent of the chemical reactions and pathways involving nucleobases, nucleosides, nucleotides and nucleic acids. +-------------------------------------- +GOID: GO:0045937 +Term: positive regulation of phosphate metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways involving phosphates. +-------------------------------------- +GOID: GO:0045944 +Term: positive regulation of transcription from RNA polymerase II promoter +Definition: Any process that activates or increases the frequency, rate or extent of transcription from an RNA polymerase II promoter. +-------------------------------------- +GOID: GO:0048514 +Term: blood vessel morphogenesis +Definition: The process in which the anatomical structures of blood vessels are generated and organized. The blood vessel is the vasculature carrying blood. +-------------------------------------- +GOID: GO:0050900 +Term: leukocyte migration +Definition: The movement of a leukocyte within or between different tissues and organs of the body. +-------------------------------------- +GOID: GO:0051047 +Term: positive regulation of secretion +Definition: Any process that activates or increases the frequency, rate or extent of the controlled release of a substance from a cell or a tissue. +-------------------------------------- +GOID: GO:0051094 +Term: positive regulation of developmental process +Definition: Any process that activates or increases the rate or extent of development, the biological process whose specific outcome is the progression of an organism over time from an initial condition (e.g. a zygote, or a young adult) to a later condition (e.g. a multicellular animal or an aged adult). +-------------------------------------- +GOID: GO:0051130 +Term: positive regulation of cellular component organization +Definition: Any process that activates or increases the frequency, rate or extent of a process involved in the formation, arrangement of constituent parts, or disassembly of cell structures, including the plasma membrane and any external encapsulating structures such as the cell wall and cell envelope. +-------------------------------------- +GOID: GO:0051173 +Term: positive regulation of nitrogen compound metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways involving nitrogen or nitrogenous compounds. +-------------------------------------- +GOID: GO:0051174 +Term: regulation of phosphorus metabolic process +Definition: Any process that modulates the frequency, rate or extent of the chemical reactions and pathways involving phosphorus or compounds containing phosphorus. +-------------------------------------- +GOID: GO:0051223 +Term: regulation of protein transport +Definition: Any process that modulates the frequency, rate or extent of the directed movement of a protein into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:0051254 +Term: positive regulation of RNA metabolic process +Definition: Any process that activates or increases the frequency, rate or extent of the chemical reactions and pathways involving RNA. +-------------------------------------- +GOID: GO:0051649 +Term: establishment of localization in cell +Definition: Any process, occuring in a cell, that localizes a substance or cellular component. This may occur via movement, tethering or selective degradation. +-------------------------------------- +GOID: GO:0060341 +Term: regulation of cellular localization +Definition: Any process that modulates the frequency, rate or extent of a process in which a cell, a substance, or a cellular entity is transported to, or maintained in a specific location within or in the membrane of a cell. +-------------------------------------- +GOID: GO:0060429 +Term: epithelium development +Definition: The process whose specific outcome is the progression of an epithelium over time, from its formation to the mature structure. An epithelium is a tissue that covers the internal or external surfaces of an anatomical structure. +-------------------------------------- +GOID: GO:0060548 +Term: negative regulation of cell death +Definition: Any process that decreases the rate or frequency of cell death. Cell death is the specific activation or halting of processes within a cell so that its vital functions markedly cease, rather than simply deteriorating gradually over time, which culminates in cell death. +-------------------------------------- +GOID: GO:0071345 +Term: cellular response to cytokine stimulus +Definition: Any process that results in a change in state or activity of a cell (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a cytokine stimulus. +-------------------------------------- +GOID: GO:0072358 +Term: cardiovascular system development +Definition: The process whose specific outcome is the progression of the cardiovascular system over time, from its formation to the mature structure. The cardiovascular system is the anatomical system that has as its parts the heart and blood vessels. +-------------------------------------- +GOID: GO:0072359 +Term: circulatory system development +Definition: The process whose specific outcome is the progression of the circulatory system over time, from its formation to the mature structure. The circulatory system is the organ system that passes nutrients (such as amino acids and electrolytes), gases, hormones, blood cells, etc. to and from cells in the body to help fight diseases and help stabilize body temperature and pH to maintain homeostasis. +-------------------------------------- +GOID: GO:0072503 +Term: cellular divalent inorganic cation homeostasis +Definition: Any process involved in the maintenance of an internal steady state of divalent cations at the level of a cell. +-------------------------------------- +GOID: GO:0072507 +Term: divalent inorganic cation homeostasis +Definition: Any process involved in the maintenance of an internal steady state of divalent cations within an organism or cell. +-------------------------------------- +GOID: GO:0098542 +Term: defense response to other organism +Definition: Reactions triggered in response to the presence of another organism that act to protect the cell or organism from damage caused by that organism. +-------------------------------------- +GOID: GO:0098772 +Term: molecular function regulator +Definition: A molecular function that modulates the activity of a gene product or complex. Examples include enzyme regulators and channel regulators. +-------------------------------------- +GOID: GO:1902580 +Term: single-organism cellular localization +Definition: A cellular localization which involves only one organism. +-------------------------------------- +GOID: GO:1902680 +Term: positive regulation of RNA biosynthetic process +Definition: Any process that activates or increases the frequency, rate or extent of RNA biosynthetic process. +-------------------------------------- +GOID: GO:1903508 +Term: positive regulation of nucleic acid-templated transcription +Definition: Any process that activates or increases the frequency, rate or extent of nucleic acid-templated transcription. +-------------------------------------- +GOID: GO:0001818 +Term: negative regulation of cytokine production +Definition: Any process that stops, prevents, or reduces the rate of production of a cytokine. +-------------------------------------- +GOID: GO:0001819 +Term: positive regulation of cytokine production +Definition: Any process that activates or increases the frequency, rate or extent of production of a cytokine. +-------------------------------------- +GOID: GO:0001934 +Term: positive regulation of protein phosphorylation +Definition: Any process that activates or increases the frequency, rate or extent of addition of phosphate groups to amino acids within a protein. +-------------------------------------- +GOID: GO:0002253 +Term: activation of immune response +Definition: Any process that initiates an immune response. +-------------------------------------- +GOID: GO:0002443 +Term: leukocyte mediated immunity +Definition: Any process involved in the carrying out of an immune response by a leukocyte. +-------------------------------------- +GOID: GO:0002697 +Term: regulation of immune effector process +Definition: Any process that modulates the frequency, rate, or extent of an immune effector process. +-------------------------------------- +GOID: GO:0003723 +Term: RNA binding +Definition: Interacting selectively and non-covalently with an RNA molecule or a portion thereof. +-------------------------------------- +GOID: GO:0004857 +Term: enzyme inhibitor activity +Definition: Binds to and stops, prevents or reduces the activity of an enzyme. +-------------------------------------- +GOID: GO:0004866 +Term: endopeptidase inhibitor activity +Definition: Stops, prevents or reduces the activity of an endopeptidase, any enzyme that hydrolyzes nonterminal peptide bonds in polypeptides. +-------------------------------------- +GOID: GO:0005774 +Term: vacuolar membrane +Definition: The lipid bilayer surrounding the vacuole and separating its contents from the cytoplasm of the cell. +-------------------------------------- +GOID: GO:0006082 +Term: organic acid metabolic process +Definition: The chemical reactions and pathways involving organic acids, any acidic compound containing carbon in covalent linkage. +-------------------------------------- +GOID: GO:0006605 +Term: protein targeting +Definition: The process of targeting specific proteins to particular regions of the cell, typically membrane-bounded subcellular organelles. Usually requires an organelle specific protein sequence motif. +-------------------------------------- +GOID: GO:0006886 +Term: intracellular protein transport +Definition: The directed movement of proteins in a cell, including the movement of proteins between specific compartments or structures within a cell, such as organelles of a eukaryotic cell. +-------------------------------------- +GOID: GO:0006953 +Term: acute-phase response +Definition: An acute inflammatory response that involves non-antibody proteins whose concentrations in the plasma increase in response to infection or injury of homeothermic animals. +-------------------------------------- +GOID: GO:0006996 +Term: organelle organization +Definition: A process that is carried out at the cellular level which results in the assembly, arrangement of constituent parts, or disassembly of an organelle within a cell. An organelle is an organized structure of distinctive morphology and function. Includes the nucleus, mitochondria, plastids, vacuoles, vesicles, ribosomes and the cytoskeleton. Excludes the plasma membrane. +-------------------------------------- +GOID: GO:0007009 +Term: plasma membrane organization +Definition: A process that is carried out at the cellular level which results in the assembly, arrangement of constituent parts, or disassembly of the plasma membrane. +-------------------------------------- +GOID: GO:0008233 +Term: peptidase activity +Definition: Catalysis of the hydrolysis of a peptide bond. A peptide bond is a covalent bond formed when the carbon atom from the carboxyl group of one amino acid shares electrons with the nitrogen atom from the amino group of a second amino acid. +-------------------------------------- +GOID: GO:0009611 +Term: response to wounding +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus indicating damage to the organism. +-------------------------------------- +GOID: GO:0009617 +Term: response to bacterium +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus from a bacterium. +-------------------------------------- +GOID: GO:0009719 +Term: response to endogenous stimulus +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a stimulus arising within the organism. +-------------------------------------- +GOID: GO:0015075 +Term: ion transmembrane transporter activity +Definition: Enables the transfer of an ion from one side of a membrane to the other. +-------------------------------------- +GOID: GO:0016772 +Term: transferase activity, transferring phosphorus-containing groups +Definition: Catalysis of the transfer of a phosphorus-containing group from one compound (donor) to another (acceptor). +-------------------------------------- +GOID: GO:0018108 +Term: peptidyl-tyrosine phosphorylation +Definition: The phosphorylation of peptidyl-tyrosine to form peptidyl-O4'-phospho-L-tyrosine. +-------------------------------------- +GOID: GO:0018212 +Term: peptidyl-tyrosine modification +Definition: The modification of peptidyl-tyrosine. +-------------------------------------- +GOID: GO:0019752 +Term: carboxylic acid metabolic process +Definition: The chemical reactions and pathways involving carboxylic acids, any organic acid containing one or more carboxyl (COOH) groups or anions (COO-). +-------------------------------------- +GOID: GO:0022857 +Term: transmembrane transporter activity +Definition: Enables the transfer of a substance from one side of a membrane to the other. +-------------------------------------- +GOID: GO:0022891 +Term: substrate-specific transmembrane transporter activity +Definition: Enables the transfer of a specific substance or group of related substances from one side of a membrane to the other. +-------------------------------------- +GOID: GO:0022892 +Term: substrate-specific transporter activity +Definition: Enables the directed movement of a specific substance or group of related substances (such as macromolecules, small molecules, ions) into, out of or within a cell, or between cells. +-------------------------------------- +GOID: GO:0030234 +Term: enzyme regulator activity +Definition: Binds to and modulates the activity of an enzyme. +-------------------------------------- +GOID: GO:0030414 +Term: peptidase inhibitor activity +Definition: Stops, prevents or reduces the activity of a peptidase, any enzyme that catalyzes the hydrolysis peptide bonds. +-------------------------------------- +GOID: GO:0030595 +Term: leukocyte chemotaxis +Definition: The movement of a leukocyte in response to an external stimulus. +-------------------------------------- +GOID: GO:0031410 +Term: cytoplasmic vesicle +Definition: A vesicle found in the cytoplasm of a cell. +-------------------------------------- +GOID: GO:0032403 +Term: protein complex binding +Definition: Interacting selectively and non-covalently with any protein complex (a complex of two or more proteins that may include other nonprotein molecules). +-------------------------------------- +GOID: GO:0032940 +Term: secretion by cell +Definition: The controlled release of a substance by a cell. +-------------------------------------- +GOID: GO:0032989 +Term: cellular component morphogenesis +Definition: The process in which cellular structures, including whole cells or cell parts, are generated and organized. +-------------------------------------- +GOID: GO:0033993 +Term: response to lipid +Definition: Any process that results in a change in state or activity of a cell or an organism (in terms of movement, secretion, enzyme production, gene expression, etc.) as a result of a lipid stimulus. +-------------------------------------- +GOID: GO:0040008 +Term: regulation of growth +Definition: Any process that modulates the frequency, rate or extent of the growth of all or part of an organism so that it occurs at its proper speed, either globally or in a specific part of the organism's development. +-------------------------------------- +GOID: GO:0040012 +Term: regulation of locomotion +Definition: Any process that modulates the frequency, rate or extent of locomotion of a cell or organism. +-------------------------------------- +GOID: GO:0042060 +Term: wound healing +Definition: The series of events that restore integrity to a damaged tissue, following an injury. +-------------------------------------- +GOID: GO:0042327 +Term: positive regulation of phosphorylation +Definition: Any process that activates or increases the frequency, rate or extent of addition of phosphate groups to a molecule. +-------------------------------------- +GOID: GO:0043066 +Term: negative regulation of apoptotic process +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of cell death by apoptotic process. +-------------------------------------- +GOID: GO:0043069 +Term: negative regulation of programmed cell death +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of programmed cell death, cell death resulting from activation of endogenous cellular processes. +-------------------------------------- +GOID: GO:0043086 +Term: negative regulation of catalytic activity +Definition: Any process that stops or reduces the activity of an enzyme. +-------------------------------------- +GOID: GO:0043436 +Term: oxoacid metabolic process +Definition: The chemical reactions and pathways involving any oxoacid; an oxoacid is a compound which contains oxygen, at least one other element, and at least one hydrogen bound to oxygen, and which produces a conjugate base by loss of positive hydrogen ion(s) (hydrons). +-------------------------------------- +GOID: GO:0044092 +Term: negative regulation of molecular function +Definition: Any process that stops or reduces the rate or extent of a molecular function, an elemental biological activity occurring at the molecular level, such as catalysis or binding. +-------------------------------------- +GOID: GO:0044093 +Term: positive regulation of molecular function +Definition: Any process that activates or increases the rate or extent of a molecular function, an elemental biological activity occurring at the molecular level, such as catalysis or binding. +-------------------------------------- +GOID: GO:0044248 +Term: cellular catabolic process +Definition: The chemical reactions and pathways resulting in the breakdown of substances, carried out by individual cells. +-------------------------------------- +GOID: GO:0044437 +Term: vacuolar part +Definition: Any constituent part of a vacuole, a closed structure, found only in eukaryotic cells, that is completely surrounded by unit membrane and contains liquid material. +-------------------------------------- +GOID: GO:0044802 +Term: single-organism membrane organization +Definition: A process which results in the assembly, arrangement of constituent parts, or disassembly of a membrane, involving only one organism. +-------------------------------------- +GOID: GO:0044822 +Term: poly(A) RNA binding +Definition: Interacting non-covalently with a poly(A) RNA, a RNA molecule which has a tail of adenine bases. +-------------------------------------- +GOID: GO:0045596 +Term: negative regulation of cell differentiation +Definition: Any process that stops, prevents, or reduces the frequency, rate or extent of cell differentiation. +-------------------------------------- +GOID: GO:0046907 +Term: intracellular transport +Definition: The directed movement of substances within a cell. +-------------------------------------- +GOID: GO:0046916 +Term: cellular transition metal ion homeostasis +Definition: Any process involved in the maintenance of an internal steady state of transition metal ions at the level of a cell. A transition metal is an element whose atom has an incomplete d-subshell of extranuclear electrons, or which gives rise to a cation or cations with an incomplete d-subshell. Transition metals often have more than one valency state. Biologically relevant transition metals include vanadium, manganese, iron, copper, cobalt, nickel, molybdenum and silver. +-------------------------------------- +GOID: GO:0046983 +Term: protein dimerization activity +Definition: The formation of a protein dimer, a macromolecular structure consists of two noncovalently associated identical or nonidentical subunits. +-------------------------------------- +GOID: GO:0050877 +Term: neurological system process +Definition: A organ system process carried out by any of the organs or tissues of neurological system. +-------------------------------------- +GOID: GO:0051093 +Term: negative regulation of developmental process +Definition: Any process that stops, prevents or reduces the rate or extent of development, the biological process whose specific outcome is the progression of an organism over time from an initial condition (e.g. a zygote, or a young adult) to a later condition (e.g. a multicellular animal or an aged adult). +-------------------------------------- +GOID: GO:0052547 +Term: regulation of peptidase activity +Definition: Any process that modulates the frequency, rate or extent of peptidase activity, the hydrolysis of peptide bonds within proteins. +-------------------------------------- +GOID: GO:0055085 +Term: transmembrane transport +Definition: The process in which a solute is transported across a lipid bilayer, from one side of a membrane to the other +-------------------------------------- +GOID: GO:0061134 +Term: peptidase regulator activity +Definition: Modulates the activity of a peptidase, any enzyme that catalyzes the hydrolysis peptide bonds. +-------------------------------------- +GOID: GO:0061135 +Term: endopeptidase regulator activity +Definition: Modulates the activity of a peptidase, any enzyme that hydrolyzes nonterminal peptide bonds in polypeptides. +-------------------------------------- +GOID: GO:0070011 +Term: peptidase activity, acting on L-amino acid peptides +Definition: Catalysis of the hydrolysis of peptide bonds formed between L-amino acids. +-------------------------------------- +GOID: GO:0071705 +Term: nitrogen compound transport +Definition: The directed movement of nitrogen-containing compounds into, out of or within a cell, or between cells, by means of some agent such as a transporter or pore. +-------------------------------------- +GOID: GO:0097529 +Term: myeloid leukocyte migration +Definition: The movement of a myeloid leukocyte within or between different tissues and organs of the body. +-------------------------------------- +GOID: GO:0097708 +Term: intracellular vesicle +Definition: Any vesicle that is part of the intracellular region. +-------------------------------------- +GOID: GO:0098602 +Term: single organism cell adhesion +Definition: The attachment, via cell adhesion molecules, of a cell to either another cell of the same organism, or to an underlying substrate of the same organism such as the extracellular matrix. +-------------------------------------- +GOID: GO:1901575 +Term: organic substance catabolic process +Definition: The chemical reactions and pathways resulting in the breakdown of an organic substance, any molecular entity containing carbon. +-------------------------------------- +GOID: GO:1902582 +Term: single-organism intracellular transport +Definition: An intracellular transport which involves only one organism. +-------------------------------------- +GOID: GO:1902589 +Term: single-organism organelle organization +Definition: An organelle organization which involves only one organism. +-------------------------------------- +GOID: GO:1903827 +Term: regulation of cellular protein localization +Definition: Any process that modulates the frequency, rate or extent of cellular protein localization. Cellular protein localization is any process in which a protein is transported to, and/or maintained in, a specific location and encompasses movement within the cell, from within the cell to the cell surface, or from one location to another at the surface of a cell. +-------------------------------------- +GOID: GO:1904951 +Term: positive regulation of establishment of protein localization +Definition: Any process that activates or increases the frequency, rate or extent of establishment of protein localization. +-------------------------------------- +