Introduction

This code is available at https://github.com/aaronsk7/guppy-methylation

This script performs enrichment analysis of methylkit results.

Load in packages

library("R.utils")
## Loading required package: R.oo
## Loading required package: R.methodsS3
## R.methodsS3 v1.8.1 (2020-08-26 16:20:06 UTC) successfully loaded. See ?R.methodsS3 for help.
## R.oo v1.24.0 (2020-08-26 16:11:58 UTC) successfully loaded. See ?R.oo for help.
## 
## Attaching package: 'R.oo'
## The following object is masked from 'package:R.methodsS3':
## 
##     throw
## The following objects are masked from 'package:methods':
## 
##     getClasses, getMethods
## The following objects are masked from 'package:base':
## 
##     attach, detach, load, save
## R.utils v2.10.1 (2020-08-26 22:50:31 UTC) successfully loaded. See ?R.utils for help.
## 
## Attaching package: 'R.utils'
## The following object is masked from 'package:utils':
## 
##     timestamp
## The following objects are masked from 'package:base':
## 
##     cat, commandArgs, getOption, inherits, isOpen, nullfile, parse,
##     warnings
library("parallel")
library("reshape2")
library("kableExtra")
library("dplyr")
## 
## Attaching package: 'dplyr'
## The following object is masked from 'package:kableExtra':
## 
##     group_rows
## The following objects are masked from 'package:stats':
## 
##     filter, lag
## The following objects are masked from 'package:base':
## 
##     intersect, setdiff, setequal, union
library("RColorBrewer")
library("GenomicRanges")
## Loading required package: stats4
## Loading required package: BiocGenerics
## 
## Attaching package: 'BiocGenerics'
## The following objects are masked from 'package:dplyr':
## 
##     combine, intersect, setdiff, union
## The following objects are masked from 'package:parallel':
## 
##     clusterApply, clusterApplyLB, clusterCall, clusterEvalQ,
##     clusterExport, clusterMap, parApply, parCapply, parLapply,
##     parLapplyLB, parRapply, parSapply, parSapplyLB
## The following objects are masked from 'package:stats':
## 
##     IQR, mad, sd, var, xtabs
## The following objects are masked from 'package:base':
## 
##     anyDuplicated, append, as.data.frame, basename, cbind, colnames,
##     dirname, do.call, duplicated, eval, evalq, Filter, Find, get, grep,
##     grepl, intersect, is.unsorted, lapply, Map, mapply, match, mget,
##     order, paste, pmax, pmax.int, pmin, pmin.int, Position, rank,
##     rbind, Reduce, rownames, sapply, setdiff, sort, table, tapply,
##     union, unique, unsplit, which.max, which.min
## Loading required package: S4Vectors
## 
## Attaching package: 'S4Vectors'
## The following objects are masked from 'package:dplyr':
## 
##     first, rename
## The following objects are masked from 'package:base':
## 
##     expand.grid, I, unname
## Loading required package: IRanges
## 
## Attaching package: 'IRanges'
## The following objects are masked from 'package:dplyr':
## 
##     collapse, desc, slice
## The following object is masked from 'package:R.oo':
## 
##     trim
## Loading required package: GenomeInfoDb
library("limma")
## 
## Attaching package: 'limma'
## The following object is masked from 'package:BiocGenerics':
## 
##     plotMA
library("methylKit")
## 
## Attaching package: 'methylKit'
## The following object is masked from 'package:dplyr':
## 
##     select
library("gplots")
## 
## Attaching package: 'gplots'
## The following object is masked from 'package:IRanges':
## 
##     space
## The following object is masked from 'package:S4Vectors':
## 
##     space
## The following object is masked from 'package:stats':
## 
##     lowess
library("seqinr")
## 
## Attaching package: 'seqinr'
## The following object is masked from 'package:limma':
## 
##     zscore
## The following object is masked from 'package:dplyr':
## 
##     count
## The following object is masked from 'package:R.oo':
## 
##     getName
library("mitch")
## Registered S3 method overwritten by 'GGally':
##   method from   
##   +.gg   ggplot2
library("getDEE2") 
library("DESeq2")
## Loading required package: SummarizedExperiment
## Loading required package: MatrixGenerics
## Loading required package: matrixStats
## 
## Attaching package: 'matrixStats'
## The following object is masked from 'package:seqinr':
## 
##     count
## The following object is masked from 'package:dplyr':
## 
##     count
## 
## Attaching package: 'MatrixGenerics'
## The following objects are masked from 'package:matrixStats':
## 
##     colAlls, colAnyNAs, colAnys, colAvgsPerRowSet, colCollapse,
##     colCounts, colCummaxs, colCummins, colCumprods, colCumsums,
##     colDiffs, colIQRDiffs, colIQRs, colLogSumExps, colMadDiffs,
##     colMads, colMaxs, colMeans2, colMedians, colMins, colOrderStats,
##     colProds, colQuantiles, colRanges, colRanks, colSdDiffs, colSds,
##     colSums2, colTabulates, colVarDiffs, colVars, colWeightedMads,
##     colWeightedMeans, colWeightedMedians, colWeightedSds,
##     colWeightedVars, rowAlls, rowAnyNAs, rowAnys, rowAvgsPerColSet,
##     rowCollapse, rowCounts, rowCummaxs, rowCummins, rowCumprods,
##     rowCumsums, rowDiffs, rowIQRDiffs, rowIQRs, rowLogSumExps,
##     rowMadDiffs, rowMads, rowMaxs, rowMeans2, rowMedians, rowMins,
##     rowOrderStats, rowProds, rowQuantiles, rowRanges, rowRanks,
##     rowSdDiffs, rowSds, rowSums2, rowTabulates, rowVarDiffs, rowVars,
##     rowWeightedMads, rowWeightedMeans, rowWeightedMedians,
##     rowWeightedSds, rowWeightedVars
## Loading required package: Biobase
## Welcome to Bioconductor
## 
##     Vignettes contain introductory material; view with
##     'browseVignettes()'. To cite Bioconductor, see
##     'citation("Biobase")', and for packages 'citation("pkgname")'.
## 
## Attaching package: 'Biobase'
## The following object is masked from 'package:MatrixGenerics':
## 
##     rowMedians
## The following objects are masked from 'package:matrixStats':
## 
##     anyMissing, rowMedians
library("clusterProfiler")
## 
## clusterProfiler v4.0.5  For help: https://yulab-smu.top/biomedical-knowledge-mining-book/
## 
## If you use clusterProfiler in published research, please cite:
## T Wu, E Hu, S Xu, M Chen, P Guo, Z Dai, T Feng, L Zhou, W Tang, L Zhan, X Fu, S Liu, X Bo, and G Yu. clusterProfiler 4.0: A universal enrichment tool for interpreting omics data. The Innovation. 2021, 2(3):100141. doi: 10.1016/j.xinn.2021.100141
## 
## Attaching package: 'clusterProfiler'
## The following object is masked from 'package:methylKit':
## 
##     select
## The following object is masked from 'package:IRanges':
## 
##     slice
## The following object is masked from 'package:S4Vectors':
## 
##     rename
## The following object is masked from 'package:stats':
## 
##     filter
library("eulerr")
## Registered S3 method overwritten by 'eulerr':
##   method    from  
##   plot.venn gplots
## 
## Attaching package: 'eulerr'
## The following object is masked from 'package:gplots':
## 
##     venn

Import methylation data

Import promoter differential methylation data.

Import the gene sets.

CvG <- readRDS("CvGtiles_genepromoters.rds")
CvL <- readRDS("CvLtiles_genepromoters.rds")
GvL <- readRDS("GvLtiles_genepromoters.rds")
head(CvG)
##       seqnames    start      end width strand        pvalue        qvalue
## 86983      LG4  1847001  1848000  1000      * 9.714622e-131 4.885614e-125
## 86984      LG4  1847001  1848000  1000      * 9.714622e-131 4.885614e-125
## 86981      LG4  1846001  1847000  1000      *  1.196917e-89  3.009727e-84
## 86982      LG4  1846001  1847000  1000      *  1.196917e-89  3.009727e-84
## 6509       LG1  9073001  9074000  1000      *  3.550053e-47  2.550528e-42
## 8294       LG1 17897001 17898000  1000      *  1.654721e-42  9.246461e-38
##       meth.diff            gene_id                 V6       gene_name
## 86983 19.239478 ENSPREG00000021468 ENSPRET00000032035           gpc5b
## 86984 19.239478 ENSPREG00000021490 ENSPRET00000032090            nasp
## 86981 19.897694 ENSPREG00000021468 ENSPRET00000032035           gpc5b
## 86982 19.897694 ENSPREG00000021490 ENSPRET00000032090            nasp
## 6509  14.606176 ENSPREG00000000312 ENSPRET00000000435            slx4
## 8294  -6.231157 ENSPREG00000004582 ENSPRET00000006703 uncharacterised
head(CvL)
##        seqnames    start      end width strand       pvalue       qvalue
## 63161       LG2 20995001 20996000  1000      * 4.065070e-48 2.956357e-43
## 106383      LG7 18259001 18260000  1000      * 8.559718e-41 4.357590e-36
## 20949      LG11 28461001 28462000  1000      * 1.078697e-40 4.992221e-36
## 70661      LG21   538001   539000  1000      * 5.735034e-40 2.432998e-35
## 31311      LG14  4148001  4149000  1000      * 8.688214e-40 3.402312e-35
## 20618      LG11 27368001 27369000  1000      * 1.892756e-31 4.588411e-27
##        meth.diff            gene_id                 V6       gene_name
## 63161  -20.26683 ENSPREG00000014846 ENSPRET00000022204      zgc:194275
## 106383  23.29152 ENSPREG00000003617 ENSPRET00000005305           uts2a
## 20949  -13.62358 ENSPREG00000010182 ENSPRET00000015234          tfap2e
## 70661  -13.78305 ENSPREG00000012722 ENSPRET00000019142 uncharacterised
## 31311  -21.04322 ENSPREG00000009393 ENSPRET00000014038      zgc:112437
## 20618   13.36592 ENSPREG00000008406 ENSPRET00000012667         fabp10b
head(GvL)
##       seqnames   start     end width strand        pvalue        qvalue
## 88849      LG4 1847001 1848000  1000      * 7.503577e-141 3.921253e-135
## 88850      LG4 1847001 1848000  1000      * 7.503577e-141 3.921253e-135
## 88847      LG4 1846001 1847000  1000      * 8.017760e-104  2.094979e-98
## 88848      LG4 1846001 1847000  1000      * 8.017760e-104  2.094979e-98
## 72353     LG21  538001  539000  1000      *  5.180641e-40  4.512205e-35
## 32069     LG14 4148001 4149000  1000      *  2.644311e-35  1.727345e-30
##       meth.diff            gene_id      transcript_id       gene_name
## 88849 -19.01626 ENSPREG00000021468 ENSPRET00000032035           gpc5b
## 88850 -19.01626 ENSPREG00000021490 ENSPRET00000032090            nasp
## 88847 -19.30979 ENSPREG00000021468 ENSPRET00000032035           gpc5b
## 88848 -19.30979 ENSPREG00000021490 ENSPRET00000032090            nasp
## 72353 -12.60888 ENSPREG00000012722 ENSPRET00000019142 uncharacterised
## 32069 -17.15105 ENSPREG00000009393 ENSPRET00000014038      zgc:112437

Import gene ontology data

Downloaded from ensembl biomart on 8th October 2021. http://www.ensembl.org/biomart/martview/98242811709db7335e2470900eef0f89

#go <- read.table("mart_export.txt.gz",fill=TRUE,sep="\t")
go <- readLines("mart_export.txt.gz")
#go <- head(go,1000)
head(go)
## [1] "Gene stable ID\tGene stable ID version\tTranscript stable ID\tTranscript stable ID version\tGO term accession\tGO term name\tGO term definition\tGO domain\tGO term evidence code\tGOSlim GOA Accession(s)\tGOSlim GOA Description"                                                                                                                                                
## [2] "ENSPREG00000000007\tENSPREG00000000007.1\tENSPRET00000000007\tENSPRET00000000007.1\tGO:0008137\tNADH dehydrogenase (ubiquinone) activity\tCatalysis of the reaction: NADH + ubiquinone + 5 H(+)(in) <=> NAD(+) + ubiquinol + 4 H(+)(out).\tmolecular_function\tIEA\tGO:0003674\tmolecular_function"                                                                                
## [3] "ENSPREG00000000007\tENSPREG00000000007.1\tENSPRET00000000007\tENSPRET00000000007.1\tGO:0005739\tmitochondrion\tA 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.\tcellular_component\tIEA\tGO:0003674\tmolecular_function"          
## [4] "ENSPREG00000000007\tENSPREG00000000007.1\tENSPRET00000000007\tENSPRET00000000007.1\tGO:0016020\tmembrane\tA lipid bilayer along with all the proteins and protein complexes embedded in it an attached to it.\tcellular_component\tIEA\tGO:0003674\tmolecular_function"                                                                                                            
## [5] "ENSPREG00000000007\tENSPREG00000000007.1\tENSPRET00000000007\tENSPRET00000000007.1\tGO:0016021\tintegral component of membrane\tThe 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.\tcellular_component\tIEA\tGO:0003674\tmolecular_function"
## [6] "ENSPREG00000000007\tENSPREG00000000007.1\tENSPRET00000000007\tENSPRET00000000007.1\tGO:0005743\tmitochondrial inner membrane\tThe inner, i.e. lumen-facing, lipid bilayer of the mitochondrial envelope. It is highly folded to form cristae.\tcellular_component\tIEA\tGO:0003674\tmolecular_function"
gol <- (strsplit(go,"\t"))
head(gol)
## [[1]]
##  [1] "Gene stable ID"               "Gene stable ID version"      
##  [3] "Transcript stable ID"         "Transcript stable ID version"
##  [5] "GO term accession"            "GO term name"                
##  [7] "GO term definition"           "GO domain"                   
##  [9] "GO term evidence code"        "GOSlim GOA Accession(s)"     
## [11] "GOSlim GOA Description"      
## 
## [[2]]
##  [1] "ENSPREG00000000007"                                                                             
##  [2] "ENSPREG00000000007.1"                                                                           
##  [3] "ENSPRET00000000007"                                                                             
##  [4] "ENSPRET00000000007.1"                                                                           
##  [5] "GO:0008137"                                                                                     
##  [6] "NADH dehydrogenase (ubiquinone) activity"                                                       
##  [7] "Catalysis of the reaction: NADH + ubiquinone + 5 H(+)(in) <=> NAD(+) + ubiquinol + 4 H(+)(out)."
##  [8] "molecular_function"                                                                             
##  [9] "IEA"                                                                                            
## [10] "GO:0003674"                                                                                     
## [11] "molecular_function"                                                                             
## 
## [[3]]
##  [1] "ENSPREG00000000007"                                                                                                                                                                              
##  [2] "ENSPREG00000000007.1"                                                                                                                                                                            
##  [3] "ENSPRET00000000007"                                                                                                                                                                              
##  [4] "ENSPRET00000000007.1"                                                                                                                                                                            
##  [5] "GO:0005739"                                                                                                                                                                                      
##  [6] "mitochondrion"                                                                                                                                                                                   
##  [7] "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."
##  [8] "cellular_component"                                                                                                                                                                              
##  [9] "IEA"                                                                                                                                                                                             
## [10] "GO:0003674"                                                                                                                                                                                      
## [11] "molecular_function"                                                                                                                                                                              
## 
## [[4]]
##  [1] "ENSPREG00000000007"                                                                                 
##  [2] "ENSPREG00000000007.1"                                                                               
##  [3] "ENSPRET00000000007"                                                                                 
##  [4] "ENSPRET00000000007.1"                                                                               
##  [5] "GO:0016020"                                                                                         
##  [6] "membrane"                                                                                           
##  [7] "A lipid bilayer along with all the proteins and protein complexes embedded in it an attached to it."
##  [8] "cellular_component"                                                                                 
##  [9] "IEA"                                                                                                
## [10] "GO:0003674"                                                                                         
## [11] "molecular_function"                                                                                 
## 
## [[5]]
##  [1] "ENSPREG00000000007"                                                                                                                                                                       
##  [2] "ENSPREG00000000007.1"                                                                                                                                                                     
##  [3] "ENSPRET00000000007"                                                                                                                                                                       
##  [4] "ENSPRET00000000007.1"                                                                                                                                                                     
##  [5] "GO:0016021"                                                                                                                                                                               
##  [6] "integral component of membrane"                                                                                                                                                           
##  [7] "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."
##  [8] "cellular_component"                                                                                                                                                                       
##  [9] "IEA"                                                                                                                                                                                      
## [10] "GO:0003674"                                                                                                                                                                               
## [11] "molecular_function"                                                                                                                                                                       
## 
## [[6]]
##  [1] "ENSPREG00000000007"                                                                                             
##  [2] "ENSPREG00000000007.1"                                                                                           
##  [3] "ENSPRET00000000007"                                                                                             
##  [4] "ENSPRET00000000007.1"                                                                                           
##  [5] "GO:0005743"                                                                                                     
##  [6] "mitochondrial inner membrane"                                                                                   
##  [7] "The inner, i.e. lumen-facing, lipid bilayer of the mitochondrial envelope. It is highly folded to form cristae."
##  [8] "cellular_component"                                                                                             
##  [9] "IEA"                                                                                                            
## [10] "GO:0003674"                                                                                                     
## [11] "molecular_function"
godf <- do.call(rbind,gol)
colnames(godf) <- godf[1,]
godf <- godf[2:nrow(godf),]
gos <- unique(godf[,"GO term accession"])
mysets <- lapply(gos,function(x) { unique(godf[which(x == godf[,"GO term accession"]),1])  } )
mynames <- sapply(gos,function(x) { unname(godf[head(which(x == godf[,"GO term accession"] ),1),"GO term name"] ) } )
mynames <- paste(gos,mynames)
names(mysets) <- mynames

Now format the methylation data for and run mitch

This might take a few minutes - get a cuppa.

CvG$score <- sign(CvG$meth.diff)/-log(CvG$pvalue)
CvG[is.na(CvG$score),"score"] <- 0
pp <- CvG[,c("gene_id","score")]
pp <- subset(pp, !duplicated(pp$gene_id))
rownames(pp) <- pp$gene_id
pp$gene_id=NULL
head(pp)
##                           score
## ENSPREG00000021468  0.003340404
## ENSPREG00000021490  0.003340404
## ENSPREG00000000312  0.009349767
## ENSPREG00000004582 -0.010394476
## ENSPREG00000004594 -0.010394476
## ENSPREG00000003390 -0.013098962
res <- mitch_calc(x=pp,genesets=mysets,resrows=50)
## Note: When prioritising by significance (ie: small
##             p-values), large effect sizes might be missed.
head(res$enrichment_result,15)
##                                                               set setSize
## 794                                  GO:0051087 chaperone binding      12
## 983                                 GO:0005833 hemoglobin complex      12
## 303                         GO:0006289 nucleotide-excision repair      13
## 596                              GO:0030509 BMP signaling pathway      21
## 532                          GO:0004879 nuclear receptor activity      38
## 521                                      GO:0001947 heart looping      72
## 214                                        GO:0005525 GTP binding     450
## 622           GO:0043231 intracellular membrane-bounded organelle      17
## 139           GO:0043065 positive regulation of apoptotic process      21
## 259                                    GO:0008033 tRNA processing      52
## 190 GO:0004114 3',5'-cyclic-nucleotide phosphodiesterase activity      31
## 533           GO:0030522 intracellular receptor signaling pathway      27
## 980                            GO:0005344 oxygen carrier activity      16
## 981                                     GO:0019825 oxygen binding      16
## 982                                   GO:0015671 oxygen transport      16
##           pANOVA      s.dist p.adjustANOVA
## 794 0.0001734901 -0.62590559     0.1715817
## 983 0.0003834717 -0.59197986     0.1896268
## 303 0.0007118686 -0.54215119     0.2094426
## 596 0.0008470885 -0.42058856     0.2094426
## 532 0.0016778551  0.29452000     0.3318797
## 521 0.0040203105 -0.19604510     0.5769960
## 214 0.0041377325  0.07886582     0.5769960
## 622 0.0049707973 -0.39346926     0.5769960
## 139 0.0052507218  0.35182242     0.5769960
## 259 0.0061508055 -0.21960433     0.5907369
## 190 0.0065703798  0.28202466     0.5907369
## 533 0.0077505891  0.29603867     0.6097574
## 980 0.0092480903 -0.37580533     0.6097574
## 981 0.0092480903 -0.37580533     0.6097574
## 982 0.0092480903 -0.37580533     0.6097574
mitch_plots(res,outfile="mitch_plots.pdf")
## png 
##   2
unlink("mitch_report.html")
#mitch_report(res,outfile="mitch_report.html")
CvL$score <- sign(CvL$meth.diff)/-log(CvL$pvalue)
CvL[is.na(CvL$score),"score"] <- 0
pp <- CvL[,c("gene_id","score")]
pp <- subset(pp, !duplicated(pp$gene_id))
rownames(pp) <- pp$gene_id
pp$gene_id=NULL
head(pp)
##                           score
## ENSPREG00000014846 -0.009164084
## ENSPREG00000003617  0.010839060
## ENSPREG00000010182 -0.010866299
## ENSPREG00000012722 -0.011067234
## ENSPREG00000009393 -0.011118346
## ENSPREG00000008406  0.014135853
res <- mitch_calc(x=pp,genesets=mysets,resrows=50)
## Note: When prioritising by significance (ie: small
##             p-values), large effect sizes might be missed.
head(res$enrichment_result,15)
##                                                          set setSize
## 852  GO:0033179 proton-transporting V-type ATPase, V0 domain      11
## 475                       GO:0016042 lipid catabolic process      63
## 105                GO:0007218 neuropeptide signaling pathway      33
## 585                 GO:0005184 neuropeptide hormone activity      14
## 885                                       GO:0005901 caveola      20
## 942                  GO:0030516 regulation of axon extension      10
## 406                     GO:0006417 regulation of translation      40
## 597 GO:0060027 convergent extension involved in gastrulation      39
## 342                            GO:0000902 cell morphogenesis      18
## 928                             GO:0043005 neuron projection      10
## 658                                 GO:0030027 lamellipodium      42
## 236           GO:0019221 cytokine-mediated signaling pathway      29
## 260                              GO:0030488 tRNA methylation      15
## 551            GO:0007519 skeletal muscle tissue development      39
## 515                  GO:0006979 response to oxidative stress      23
##           pANOVA     s.dist p.adjustANOVA
## 852 0.0009029654  0.5778944     0.8810044
## 475 0.0023418376  0.2216631     0.8810044
## 105 0.0026751147 -0.3020093     0.8810044
## 585 0.0053745076 -0.4296577     0.9182117
## 885 0.0058290972  0.3561129     0.9182117
## 942 0.0065030817 -0.4969357     0.9182117
## 406 0.0065055484 -0.2486294     0.9182117
## 597 0.0090395605  0.2415591     0.9568378
## 342 0.0095375465  0.3528884     0.9568378
## 928 0.0135377050  0.4509295     0.9568378
## 658 0.0135392364 -0.2201908     0.9568378
## 236 0.0143828692 -0.2625790     0.9568378
## 260 0.0164616065  0.3576710     0.9568378
## 551 0.0170373301  0.2207744     0.9568378
## 515 0.0172476001 -0.2868359     0.9568378
mitch_plots(res,outfile="mitch_plots.pdf")
## png 
##   2
unlink("mitch_report.html")
#mitch_report(res,outfile="mitch_report.html")
GvL$score <- sign(GvL$meth.diff)/-log(GvL$pvalue)
GvL[is.na(GvL$score),"score"] <- 0
pp <- GvL[,c("gene_id","score")]
pp <- subset(pp, !duplicated(pp$gene_id))
rownames(pp) <- pp$gene_id
pp$gene_id=NULL
head(pp)
##                           score
## ENSPREG00000021468 -0.003099342
## ENSPREG00000021490 -0.003099342
## ENSPREG00000012722 -0.011054796
## ENSPREG00000009393 -0.012559963
## ENSPREG00000002699  0.012747733
## ENSPREG00000004582  0.013337674
res <- mitch_calc(x=pp,genesets=mysets,resrows=50)
## Note: When prioritising by significance (ie: small
##             p-values), large effect sizes might be missed.
head(res$enrichment_result,15)
##                                                                                                                                                                                                        set
## 621                                                                                                                                                                                GO:0050661 NADP binding
## 882                                                                                                                                                    GO:0021522 spinal cord motor neuron differentiation
## 115                                                                                                                                                        GO:0002224 toll-like receptor signaling pathway
## 217                                                                                                                                                                   GO:0005096 GTPase activator activity
## 412                                                                                                                                                                           GO:0007420 brain development
## 732                                                                                                                                                                     GO:0032580 Golgi cisterna membrane
## 225                                                                                                                                                               GO:0042742 defense response to bacterium
## 29  GO:0016712 oxidoreductase activity, acting on paired donors, with incorporation or reduction of molecular oxygen, reduced flavin or flavoprotein as one donor, and incorporation of one atom of oxygen
## 304                                                                                                                                                                                  GO:0006281 DNA repair
## 68                                                                                                                                                    GO:0007264 small GTPase mediated signal transduction
## 934                                                                                                                                                   GO:0015035 protein disulfide oxidoreductase activity
## 218                                                                                                                                                      GO:0043547 positive regulation of GTPase activity
## 272                                                                                                                                                           GO:0061630 ubiquitin protein ligase activity
## 188                                                                                                                                                                                  GO:0007049 cell cycle
## 369                                                                                                                                                      GO:0005164 tumor necrosis factor receptor binding
##     setSize       pANOVA     s.dist p.adjustANOVA
## 621      22 0.0007207875  0.4164207     0.5475375
## 882      16 0.0014333236  0.4602702     0.5475375
## 115      21 0.0024467860  0.3818918     0.5475375
## 217     146 0.0024865080 -0.1450227     0.5475375
## 412     109 0.0027653407 -0.1659072     0.5475375
## 732      30 0.0051948564 -0.2947819     0.7938422
## 225      35 0.0065184078  0.2657010     0.7938422
## 29       13 0.0065513932 -0.4354796     0.7938422
## 304     132 0.0080262148  0.1336215     0.7938422
## 68       93 0.0082969657 -0.1583746     0.7938422
## 934      16 0.0095738361 -0.3740885     0.7938422
## 218     149 0.0097512943 -0.1226650     0.7938422
## 272      78 0.0104241901 -0.1677459     0.7938422
## 188     137 0.0127542436  0.1232397     0.9014014
## 369      21 0.0141747141  0.3091710     0.9014014
mitch_plots(res,outfile="mitch_plots.pdf")
## png 
##   2
unlink("mitch_report.html")
#mitch_report(res,outfile="mitch_report.html")

Now run cluster profiler over representation analysis

library(reshape2)

mysetsdf <- melt(mysets)
head(mysetsdf)
##                value                                                  L1
## 1 ENSPREG00000000007 GO:0008137 NADH dehydrogenase (ubiquinone) activity
## 2 ENSPREG00000000011 GO:0008137 NADH dehydrogenase (ubiquinone) activity
## 3 ENSPREG00000000026 GO:0008137 NADH dehydrogenase (ubiquinone) activity
## 4 ENSPREG00000000028 GO:0008137 NADH dehydrogenase (ubiquinone) activity
## 5 ENSPREG00000000029 GO:0008137 NADH dehydrogenase (ubiquinone) activity
## 6 ENSPREG00000000033 GO:0008137 NADH dehydrogenase (ubiquinone) activity
mysetsdf <-mysetsdf[,c(2,1)]
head(mysetsdf)
##                                                    L1              value
## 1 GO:0008137 NADH dehydrogenase (ubiquinone) activity ENSPREG00000000007
## 2 GO:0008137 NADH dehydrogenase (ubiquinone) activity ENSPREG00000000011
## 3 GO:0008137 NADH dehydrogenase (ubiquinone) activity ENSPREG00000000026
## 4 GO:0008137 NADH dehydrogenase (ubiquinone) activity ENSPREG00000000028
## 5 GO:0008137 NADH dehydrogenase (ubiquinone) activity ENSPREG00000000029
## 6 GO:0008137 NADH dehydrogenase (ubiquinone) activity ENSPREG00000000033
CvG_up <- subset(CvG,meth.diff>0&qvalue<0.05)
CvG_up <- unique(CvG_up$gene_id)
str(CvG_up)
##  chr [1:2812] "ENSPREG00000021468" "ENSPREG00000021490" ...
CvG_dn <- subset(CvG,meth.diff<0&qvalue<0.05)
CvG_dn <- unique(CvG_dn$gene_id)
str(CvG_dn)
##  chr [1:5081] "ENSPREG00000004582" "ENSPREG00000004594" ...
CvG_bg <- unique(CvG$gene_id)
str(CvG_bg)
##  chr [1:21591] "ENSPREG00000021468" "ENSPREG00000021490" ...
c_up <- enricher(gene = CvG_up, universe = CvG_bg, minGSSize = 5, maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_up,15)
##                                                                                                                                    ID
## GO:0030155 regulation of cell adhesion                                                         GO:0030155 regulation of cell adhesion
## GO:0046716 muscle cell cellular homeostasis                                               GO:0046716 muscle cell cellular homeostasis
## GO:0007409 axonogenesis                                                                                       GO:0007409 axonogenesis
## GO:0030334 regulation of cell migration                                                       GO:0030334 regulation of cell migration
## GO:0014032 neural crest cell development                                                     GO:0014032 neural crest cell development
## GO:0005249 voltage-gated potassium channel activity                               GO:0005249 voltage-gated potassium channel activity
## GO:0004714 transmembrane receptor protein tyrosine kinase activity GO:0004714 transmembrane receptor protein tyrosine kinase activity
## GO:0030916 otic vesicle formation                                                                   GO:0030916 otic vesicle formation
## GO:0045176 apical protein localization                                                         GO:0045176 apical protein localization
## GO:1905606 regulation of presynapse assembly                                             GO:1905606 regulation of presynapse assembly
## GO:0003682 chromatin binding                                                                             GO:0003682 chromatin binding
## GO:0006836 neurotransmitter transport                                                           GO:0006836 neurotransmitter transport
## GO:0005096 GTPase activator activity                                                             GO:0005096 GTPase activator activity
## GO:0051260 protein homooligomerization                                                         GO:0051260 protein homooligomerization
## GO:0030318 melanocyte differentiation                                                           GO:0030318 melanocyte differentiation
##                                                                                                                           Description
## GO:0030155 regulation of cell adhesion                                                         GO:0030155 regulation of cell adhesion
## GO:0046716 muscle cell cellular homeostasis                                               GO:0046716 muscle cell cellular homeostasis
## GO:0007409 axonogenesis                                                                                       GO:0007409 axonogenesis
## GO:0030334 regulation of cell migration                                                       GO:0030334 regulation of cell migration
## GO:0014032 neural crest cell development                                                     GO:0014032 neural crest cell development
## GO:0005249 voltage-gated potassium channel activity                               GO:0005249 voltage-gated potassium channel activity
## GO:0004714 transmembrane receptor protein tyrosine kinase activity GO:0004714 transmembrane receptor protein tyrosine kinase activity
## GO:0030916 otic vesicle formation                                                                   GO:0030916 otic vesicle formation
## GO:0045176 apical protein localization                                                         GO:0045176 apical protein localization
## GO:1905606 regulation of presynapse assembly                                             GO:1905606 regulation of presynapse assembly
## GO:0003682 chromatin binding                                                                             GO:0003682 chromatin binding
## GO:0006836 neurotransmitter transport                                                           GO:0006836 neurotransmitter transport
## GO:0005096 GTPase activator activity                                                             GO:0005096 GTPase activator activity
## GO:0051260 protein homooligomerization                                                         GO:0051260 protein homooligomerization
## GO:0030318 melanocyte differentiation                                                           GO:0030318 melanocyte differentiation
##                                                                    GeneRatio
## GO:0030155 regulation of cell adhesion                                5/2380
## GO:0046716 muscle cell cellular homeostasis                           5/2380
## GO:0007409 axonogenesis                                              12/2380
## GO:0030334 regulation of cell migration                               6/2380
## GO:0014032 neural crest cell development                              9/2380
## GO:0005249 voltage-gated potassium channel activity                  18/2380
## GO:0004714 transmembrane receptor protein tyrosine kinase activity   22/2380
## GO:0030916 otic vesicle formation                                     4/2380
## GO:0045176 apical protein localization                                4/2380
## GO:1905606 regulation of presynapse assembly                          4/2380
## GO:0003682 chromatin binding                                         12/2380
## GO:0006836 neurotransmitter transport                                 7/2380
## GO:0005096 GTPase activator activity                                 30/2380
## GO:0051260 protein homooligomerization                               15/2380
## GO:0030318 melanocyte differentiation                                 9/2380
##                                                                      BgRatio
## GO:0030155 regulation of cell adhesion                               7/18074
## GO:0046716 muscle cell cellular homeostasis                          7/18074
## GO:0007409 axonogenesis                                             39/18074
## GO:0030334 regulation of cell migration                             13/18074
## GO:0014032 neural crest cell development                            27/18074
## GO:0005249 voltage-gated potassium channel activity                 74/18074
## GO:0004714 transmembrane receptor protein tyrosine kinase activity  97/18074
## GO:0030916 otic vesicle formation                                    7/18074
## GO:0045176 apical protein localization                               7/18074
## GO:1905606 regulation of presynapse assembly                         7/18074
## GO:0003682 chromatin binding                                        43/18074
## GO:0006836 neurotransmitter transport                               19/18074
## GO:0005096 GTPase activator activity                               146/18074
## GO:0051260 protein homooligomerization                              60/18074
## GO:0030318 melanocyte differentiation                               29/18074
##                                                                         pvalue
## GO:0030155 regulation of cell adhesion                             0.000657154
## GO:0046716 muscle cell cellular homeostasis                        0.000657154
## GO:0007409 axonogenesis                                            0.003329435
## GO:0030334 regulation of cell migration                            0.003882918
## GO:0014032 neural crest cell development                           0.005904426
## GO:0005249 voltage-gated potassium channel activity                0.006513720
## GO:0004714 transmembrane receptor protein tyrosine kinase activity 0.006881631
## GO:0030916 otic vesicle formation                                  0.007536119
## GO:0045176 apical protein localization                             0.007536119
## GO:1905606 regulation of presynapse assembly                       0.007536119
## GO:0003682 chromatin binding                                       0.007917874
## GO:0006836 neurotransmitter transport                              0.008081303
## GO:0005096 GTPase activator activity                               0.008257486
## GO:0051260 protein homooligomerization                             0.009559968
## GO:0030318 melanocyte differentiation                              0.009888595
##                                                                     p.adjust
## GO:0030155 regulation of cell adhesion                             0.4669079
## GO:0046716 muscle cell cellular homeostasis                        0.4669079
## GO:0007409 axonogenesis                                            0.7950773
## GO:0030334 regulation of cell migration                            0.7950773
## GO:0014032 neural crest cell development                           0.7950773
## GO:0005249 voltage-gated potassium channel activity                0.7950773
## GO:0004714 transmembrane receptor protein tyrosine kinase activity 0.7950773
## GO:0030916 otic vesicle formation                                  0.7950773
## GO:0045176 apical protein localization                             0.7950773
## GO:1905606 regulation of presynapse assembly                       0.7950773
## GO:0003682 chromatin binding                                       0.7950773
## GO:0006836 neurotransmitter transport                              0.7950773
## GO:0005096 GTPase activator activity                               0.7950773
## GO:0051260 protein homooligomerization                             0.7950773
## GO:0030318 melanocyte differentiation                              0.7950773
##                                                                       qvalue
## GO:0030155 regulation of cell adhesion                             0.4669079
## GO:0046716 muscle cell cellular homeostasis                        0.4669079
## GO:0007409 axonogenesis                                            0.7950773
## GO:0030334 regulation of cell migration                            0.7950773
## GO:0014032 neural crest cell development                           0.7950773
## GO:0005249 voltage-gated potassium channel activity                0.7950773
## GO:0004714 transmembrane receptor protein tyrosine kinase activity 0.7950773
## GO:0030916 otic vesicle formation                                  0.7950773
## GO:0045176 apical protein localization                             0.7950773
## GO:1905606 regulation of presynapse assembly                       0.7950773
## GO:0003682 chromatin binding                                       0.7950773
## GO:0006836 neurotransmitter transport                              0.7950773
## GO:0005096 GTPase activator activity                               0.7950773
## GO:0051260 protein homooligomerization                             0.7950773
## GO:0030318 melanocyte differentiation                              0.7950773
##                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                       geneID
## GO:0030155 regulation of cell adhesion                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000020191/ENSPREG00000010044/ENSPREG00000011543/ENSPREG00000019336/ENSPREG00000006389
## GO:0046716 muscle cell cellular homeostasis                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                   ENSPREG00000009411/ENSPREG00000019794/ENSPREG00000020904/ENSPREG00000012706/ENSPREG00000002855
## GO:0007409 axonogenesis                                                                                                                                                                                                                                                                                                                                                                                                  ENSPREG00000003714/ENSPREG00000009462/ENSPREG00000017257/ENSPREG00000019606/ENSPREG00000008887/ENSPREG00000013382/ENSPREG00000019248/ENSPREG00000007334/ENSPREG00000004376/ENSPREG00000000399/ENSPREG00000019454/ENSPREG00000019208
## GO:0030334 regulation of cell migration                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                    ENSPREG00000020191/ENSPREG00000010044/ENSPREG00000011543/ENSPREG00000019336/ENSPREG00000021543/ENSPREG00000010633
## GO:0014032 neural crest cell development                                                                                                                                                                                                                                                                                                                                                                                                                                          ENSPREG00000000111/ENSPREG00000020900/ENSPREG00000001888/ENSPREG00000018936/ENSPREG00000020875/ENSPREG00000018525/ENSPREG00000019652/ENSPREG00000016745/ENSPREG00000004044
## GO:0005249 voltage-gated potassium channel activity                                                                                                                                                                                                                                                    ENSPREG00000021731/ENSPREG00000016360/ENSPREG00000000873/ENSPREG00000015244/ENSPREG00000019994/ENSPREG00000018137/ENSPREG00000015851/ENSPREG00000017898/ENSPREG00000021031/ENSPREG00000001739/ENSPREG00000013809/ENSPREG00000020923/ENSPREG00000019713/ENSPREG00000019707/ENSPREG00000012123/ENSPREG00000018859/ENSPREG00000005859/ENSPREG00000021682
## GO:0004714 transmembrane receptor protein tyrosine kinase activity                                                                                                                                                         ENSPREG00000008541/ENSPREG00000009500/ENSPREG00000018326/ENSPREG00000010744/ENSPREG00000011543/ENSPREG00000006673/ENSPREG00000020900/ENSPREG00000019556/ENSPREG00000001707/ENSPREG00000005719/ENSPREG00000019336/ENSPREG00000009040/ENSPREG00000018109/ENSPREG00000003825/ENSPREG00000001857/ENSPREG00000019671/ENSPREG00000008419/ENSPREG00000002914/ENSPREG00000004058/ENSPREG00000020673/ENSPREG00000009183/ENSPREG00000004587
## GO:0030916 otic vesicle formation                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000002057/ENSPREG00000004689/ENSPREG00000001888/ENSPREG00000008334
## GO:0045176 apical protein localization                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000018047/ENSPREG00000014551/ENSPREG00000013611/ENSPREG00000013331
## GO:1905606 regulation of presynapse assembly                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                     ENSPREG00000017257/ENSPREG00000008887/ENSPREG00000019248/ENSPREG00000019208
## GO:0003682 chromatin binding                                                                                                                                                                                                                                                                                                                                                                                             ENSPREG00000020416/ENSPREG00000016522/ENSPREG00000001380/ENSPREG00000007118/ENSPREG00000018256/ENSPREG00000007490/ENSPREG00000005028/ENSPREG00000015840/ENSPREG00000019882/ENSPREG00000002725/ENSPREG00000012260/ENSPREG00000019101
## GO:0006836 neurotransmitter transport                                                                                                                                                                                                                                                                                                                                                                                                                                                                                   ENSPREG00000017749/ENSPREG00000001650/ENSPREG00000018029/ENSPREG00000020142/ENSPREG00000003012/ENSPREG00000008121/ENSPREG00000000273
## GO:0005096 GTPase activator activity                               ENSPREG00000017857/ENSPREG00000002721/ENSPREG00000009884/ENSPREG00000004344/ENSPREG00000008165/ENSPREG00000009970/ENSPREG00000021572/ENSPREG00000020745/ENSPREG00000010160/ENSPREG00000008818/ENSPREG00000021455/ENSPREG00000005604/ENSPREG00000000815/ENSPREG00000011527/ENSPREG00000003515/ENSPREG00000002871/ENSPREG00000016181/ENSPREG00000010858/ENSPREG00000021002/ENSPREG00000001038/ENSPREG00000005055/ENSPREG00000020238/ENSPREG00000003783/ENSPREG00000006835/ENSPREG00000019122/ENSPREG00000014913/ENSPREG00000015619/ENSPREG00000006302/ENSPREG00000009077/ENSPREG00000003620
## GO:0051260 protein homooligomerization                                                                                                                                                                                                                                                                                                                          ENSPREG00000021731/ENSPREG00000015244/ENSPREG00000019994/ENSPREG00000011284/ENSPREG00000021031/ENSPREG00000013809/ENSPREG00000020923/ENSPREG00000019713/ENSPREG00000004636/ENSPREG00000019707/ENSPREG00000022480/ENSPREG00000015801/ENSPREG00000018859/ENSPREG00000016649/ENSPREG00000021682
## GO:0030318 melanocyte differentiation                                                                                                                                                                                                                                                                                                                                                                                                                                             ENSPREG00000009893/ENSPREG00000002057/ENSPREG00000010109/ENSPREG00000020900/ENSPREG00000002975/ENSPREG00000005265/ENSPREG00000019772/ENSPREG00000019652/ENSPREG00000016745
##                                                                    Count
## GO:0030155 regulation of cell adhesion                                 5
## GO:0046716 muscle cell cellular homeostasis                            5
## GO:0007409 axonogenesis                                               12
## GO:0030334 regulation of cell migration                                6
## GO:0014032 neural crest cell development                               9
## GO:0005249 voltage-gated potassium channel activity                   18
## GO:0004714 transmembrane receptor protein tyrosine kinase activity    22
## GO:0030916 otic vesicle formation                                      4
## GO:0045176 apical protein localization                                 4
## GO:1905606 regulation of presynapse assembly                           4
## GO:0003682 chromatin binding                                          12
## GO:0006836 neurotransmitter transport                                  7
## GO:0005096 GTPase activator activity                                  30
## GO:0051260 protein homooligomerization                                15
## GO:0030318 melanocyte differentiation                                  9
c_dn <- enricher(gene = CvG_dn, universe = CvG_bg, minGSSize = 5,  maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_dn,15)
##                                                                                                                                        ID
## GO:0060294 cilium movement involved in cell motility                                 GO:0060294 cilium movement involved in cell motility
## GO:0007275 multicellular organism development                                               GO:0007275 multicellular organism development
## GO:0030837 negative regulation of actin filament polymerization           GO:0030837 negative regulation of actin filament polymerization
## GO:0006596 polyamine biosynthetic process                                                       GO:0006596 polyamine biosynthetic process
## GO:0030111 regulation of Wnt signaling pathway                                             GO:0030111 regulation of Wnt signaling pathway
## GO:0005515 protein binding                                                                                     GO:0005515 protein binding
## GO:0030522 intracellular receptor signaling pathway                                   GO:0030522 intracellular receptor signaling pathway
## GO:0003094 glomerular filtration                                                                         GO:0003094 glomerular filtration
## GO:0009887 animal organ morphogenesis                                                               GO:0009887 animal organ morphogenesis
## GO:0045296 cadherin binding                                                                                   GO:0045296 cadherin binding
## GO:0045104 intermediate filament cytoskeleton organization                     GO:0045104 intermediate filament cytoskeleton organization
## GO:0048484 enteric nervous system development                                               GO:0048484 enteric nervous system development
## GO:0021549 cerebellum development                                                                       GO:0021549 cerebellum development
## GO:0006384 transcription initiation from RNA polymerase III promoter GO:0006384 transcription initiation from RNA polymerase III promoter
## GO:0032422 purine-rich negative regulatory element binding                     GO:0032422 purine-rich negative regulatory element binding
##                                                                                                                               Description
## GO:0060294 cilium movement involved in cell motility                                 GO:0060294 cilium movement involved in cell motility
## GO:0007275 multicellular organism development                                               GO:0007275 multicellular organism development
## GO:0030837 negative regulation of actin filament polymerization           GO:0030837 negative regulation of actin filament polymerization
## GO:0006596 polyamine biosynthetic process                                                       GO:0006596 polyamine biosynthetic process
## GO:0030111 regulation of Wnt signaling pathway                                             GO:0030111 regulation of Wnt signaling pathway
## GO:0005515 protein binding                                                                                     GO:0005515 protein binding
## GO:0030522 intracellular receptor signaling pathway                                   GO:0030522 intracellular receptor signaling pathway
## GO:0003094 glomerular filtration                                                                         GO:0003094 glomerular filtration
## GO:0009887 animal organ morphogenesis                                                               GO:0009887 animal organ morphogenesis
## GO:0045296 cadherin binding                                                                                   GO:0045296 cadherin binding
## GO:0045104 intermediate filament cytoskeleton organization                     GO:0045104 intermediate filament cytoskeleton organization
## GO:0048484 enteric nervous system development                                               GO:0048484 enteric nervous system development
## GO:0021549 cerebellum development                                                                       GO:0021549 cerebellum development
## GO:0006384 transcription initiation from RNA polymerase III promoter GO:0006384 transcription initiation from RNA polymerase III promoter
## GO:0032422 purine-rich negative regulatory element binding                     GO:0032422 purine-rich negative regulatory element binding
##                                                                      GeneRatio
## GO:0060294 cilium movement involved in cell motility                    6/4253
## GO:0007275 multicellular organism development                         142/4253
## GO:0030837 negative regulation of actin filament polymerization         6/4253
## GO:0006596 polyamine biosynthetic process                               5/4253
## GO:0030111 regulation of Wnt signaling pathway                          5/4253
## GO:0005515 protein binding                                            858/4253
## GO:0030522 intracellular receptor signaling pathway                    13/4253
## GO:0003094 glomerular filtration                                        7/4253
## GO:0009887 animal organ morphogenesis                                   8/4253
## GO:0045296 cadherin binding                                             6/4253
## GO:0045104 intermediate filament cytoskeleton organization              9/4253
## GO:0048484 enteric nervous system development                          10/4253
## GO:0021549 cerebellum development                                       8/4253
## GO:0006384 transcription initiation from RNA polymerase III promoter    4/4253
## GO:0032422 purine-rich negative regulatory element binding              4/4253
##                                                                         BgRatio
## GO:0060294 cilium movement involved in cell motility                    7/18074
## GO:0007275 multicellular organism development                         480/18074
## GO:0030837 negative regulation of actin filament polymerization         8/18074
## GO:0006596 polyamine biosynthetic process                               6/18074
## GO:0030111 regulation of Wnt signaling pathway                          6/18074
## GO:0005515 protein binding                                           3393/18074
## GO:0030522 intracellular receptor signaling pathway                    27/18074
## GO:0003094 glomerular filtration                                       11/18074
## GO:0009887 animal organ morphogenesis                                  14/18074
## GO:0045296 cadherin binding                                             9/18074
## GO:0045104 intermediate filament cytoskeleton organization             17/18074
## GO:0048484 enteric nervous system development                          20/18074
## GO:0021549 cerebellum development                                      15/18074
## GO:0006384 transcription initiation from RNA polymerase III promoter    5/18074
## GO:0032422 purine-rich negative regulatory element binding              5/18074
##                                                                            pvalue
## GO:0060294 cilium movement involved in cell motility                 0.0009463683
## GO:0007275 multicellular organism development                        0.0011675622
## GO:0030837 negative regulation of actin filament polymerization      0.0030267614
## GO:0006596 polyamine biosynthetic process                            0.0034743789
## GO:0030111 regulation of Wnt signaling pathway                       0.0034743789
## GO:0005515 protein binding                                           0.0041551998
## GO:0030522 intracellular receptor signaling pathway                  0.0044655248
## GO:0003094 glomerular filtration                                     0.0052632219
## GO:0009887 animal organ morphogenesis                                0.0069807621
## GO:0045296 cadherin binding                                          0.0072703056
## GO:0045104 intermediate filament cytoskeleton organization           0.0081621634
## GO:0048484 enteric nervous system development                        0.0088975714
## GO:0021549 cerebellum development                                    0.0119020100
## GO:0006384 transcription initiation from RNA polymerase III promoter 0.0124325837
## GO:0032422 purine-rich negative regulatory element binding           0.0124325837
##                                                                       p.adjust
## GO:0060294 cilium movement involved in cell motility                 0.9614875
## GO:0007275 multicellular organism development                        0.9614875
## GO:0030837 negative regulation of actin filament polymerization      0.9848883
## GO:0006596 polyamine biosynthetic process                            0.9848883
## GO:0030111 regulation of Wnt signaling pathway                       0.9848883
## GO:0005515 protein binding                                           0.9848883
## GO:0030522 intracellular receptor signaling pathway                  0.9848883
## GO:0003094 glomerular filtration                                     0.9848883
## GO:0009887 animal organ morphogenesis                                0.9848883
## GO:0045296 cadherin binding                                          0.9848883
## GO:0045104 intermediate filament cytoskeleton organization           0.9848883
## GO:0048484 enteric nervous system development                        0.9848883
## GO:0021549 cerebellum development                                    0.9848883
## GO:0006384 transcription initiation from RNA polymerase III promoter 0.9848883
## GO:0032422 purine-rich negative regulatory element binding           0.9848883
##                                                                         qvalue
## GO:0060294 cilium movement involved in cell motility                 0.9614875
## GO:0007275 multicellular organism development                        0.9614875
## GO:0030837 negative regulation of actin filament polymerization      0.9848883
## GO:0006596 polyamine biosynthetic process                            0.9848883
## GO:0030111 regulation of Wnt signaling pathway                       0.9848883
## GO:0005515 protein binding                                           0.9848883
## GO:0030522 intracellular receptor signaling pathway                  0.9848883
## GO:0003094 glomerular filtration                                     0.9848883
## GO:0009887 animal organ morphogenesis                                0.9848883
## GO:0045296 cadherin binding                                          0.9848883
## GO:0045104 intermediate filament cytoskeleton organization           0.9848883
## GO:0048484 enteric nervous system development                        0.9848883
## GO:0021549 cerebellum development                                    0.9848883
## GO:0006384 transcription initiation from RNA polymerase III promoter 0.9848883
## GO:0032422 purine-rich negative regulatory element binding           0.9848883
##                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                             geneID
## GO:0060294 cilium movement involved in cell motility                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                             ENSPREG00000009719/ENSPREG00000009761/ENSPREG00000012200/ENSPREG00000009128/ENSPREG00000020731/ENSPREG00000011030
## GO:0007275 multicellular organism development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                            ENSPREG00000000612/ENSPREG00000000557/ENSPREG00000021322/ENSPREG00000021021/ENSPREG00000021717/ENSPREG00000019762/ENSPREG00000020332/ENSPREG00000017582/ENSPREG00000021719/ENSPREG00000018360/ENSPREG00000013766/ENSPREG00000003001/ENSPREG00000009481/ENSPREG00000021725/ENSPREG00000016378/ENSPREG00000010783/ENSPREG00000003088/ENSPREG00000022983/ENSPREG00000008377/ENSPREG00000004667/ENSPREG00000009349/ENSPREG00000014773/ENSPREG00000000563/ENSPREG00000010797/ENSPREG00000001340/ENSPREG00000013812/ENSPREG00000017475/ENSPREG00000005101/ENSPREG00000000133/ENSPREG00000010790/ENSPREG00000008022/ENSPREG00000005343/ENSPREG00000011756/ENSPREG00000006760/ENSPREG00000014079/ENSPREG00000002673/ENSPREG00000001346/ENSPREG00000012541/ENSPREG00000011913/ENSPREG00000007669/ENSPREG00000015465/ENSPREG00000013058/ENSPREG00000019287/ENSPREG00000009731/ENSPREG00000013353/ENSPREG00000000532/ENSPREG00000021227/ENSPREG00000006758/ENSPREG00000006190/ENSPREG00000007900/ENSPREG00000004689/ENSPREG00000011561/ENSPREG00000012697/ENSPREG00000021274/ENSPREG00000020658/ENSPREG00000006606/ENSPREG00000015499/ENSPREG00000018135/ENSPREG00000001072/ENSPREG00000008300/ENSPREG00000018299/ENSPREG00000013601/ENSPREG00000008696/ENSPREG00000018652/ENSPREG00000011038/ENSPREG00000020206/ENSPREG00000006787/ENSPREG00000000683/ENSPREG00000010793/ENSPREG00000017901/ENSPREG00000006772/ENSPREG00000009363/ENSPREG00000015450/ENSPREG00000002053/ENSPREG00000013209/ENSPREG00000023206/ENSPREG00000001810/ENSPREG00000001397/ENSPREG00000009356/ENSPREG00000004970/ENSPREG00000017077/ENSPREG00000005380/ENSPREG00000006819/ENSPREG00000011441/ENSPREG00000001804/ENSPREG00000021949/ENSPREG00000006631/ENSPREG00000008297/ENSPREG00000019085/ENSPREG00000020667/ENSPREG00000020203/ENSPREG00000002795/ENSPREG00000017001/ENSPREG00000001918/ENSPREG00000013048/ENSPREG00000020340/ENSPREG00000000163/ENSPREG00000003379/ENSPREG00000006929/ENSPREG00000021144/ENSPREG00000011620/ENSPREG00000008016/ENSPREG00000012105/ENSPREG00000015326/ENSPREG00000008325/ENSPREG00000011721/ENSPREG00000020178/ENSPREG00000011089/ENSPREG00000013684/ENSPREG00000014000/ENSPREG00000002598/ENSPREG00000023212/ENSPREG00000020538/ENSPREG00000001265/ENSPREG00000022538/ENSPREG00000015189/ENSPREG00000015884/ENSPREG00000008801/ENSPREG00000013636/ENSPREG00000003992/ENSPREG00000006101/ENSPREG00000005482/ENSPREG00000003325/ENSPREG00000014120/ENSPREG00000002679/ENSPREG00000019531/ENSPREG00000006981/ENSPREG00000021597/ENSPREG00000004436/ENSPREG00000019962/ENSPREG00000018009/ENSPREG00000007418/ENSPREG00000017669/ENSPREG00000014038/ENSPREG00000020848/ENSPREG00000003491/ENSPREG00000009171/ENSPREG00000023233/ENSPREG00000001369/ENSPREG00000006716/ENSPREG00000010959/ENSPREG00000002135
## GO:0030837 negative regulation of actin filament polymerization                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                  ENSPREG00000004859/ENSPREG00000009872/ENSPREG00000002396/ENSPREG00000022136/ENSPREG00000006482/ENSPREG00000005608
## GO:0006596 polyamine biosynthetic process                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000004500/ENSPREG00000020488/ENSPREG00000007004/ENSPREG00000016481/ENSPREG00000019739
## GO:0030111 regulation of Wnt signaling pathway                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                      ENSPREG00000006261/ENSPREG00000021155/ENSPREG00000003447/ENSPREG00000019287/ENSPREG00000011016
## GO:0005515 protein binding                                           ENSPREG00000004594/ENSPREG00000001239/ENSPREG00000002366/ENSPREG00000010979/ENSPREG00000005998/ENSPREG00000021322/ENSPREG00000015181/ENSPREG00000016753/ENSPREG00000019833/ENSPREG00000015829/ENSPREG00000007226/ENSPREG00000015671/ENSPREG00000013014/ENSPREG00000021438/ENSPREG00000015822/ENSPREG00000012815/ENSPREG00000015471/ENSPREG00000009801/ENSPREG00000014283/ENSPREG00000005618/ENSPREG00000005211/ENSPREG00000018881/ENSPREG00000022767/ENSPREG00000000629/ENSPREG00000021291/ENSPREG00000019151/ENSPREG00000012218/ENSPREG00000015447/ENSPREG00000019390/ENSPREG00000019594/ENSPREG00000010172/ENSPREG00000002074/ENSPREG00000012104/ENSPREG00000007271/ENSPREG00000009984/ENSPREG00000014822/ENSPREG00000006840/ENSPREG00000011064/ENSPREG00000017582/ENSPREG00000003556/ENSPREG00000010201/ENSPREG00000010951/ENSPREG00000008155/ENSPREG00000022366/ENSPREG00000008367/ENSPREG00000018284/ENSPREG00000003728/ENSPREG00000000414/ENSPREG00000018360/ENSPREG00000007157/ENSPREG00000018430/ENSPREG00000009378/ENSPREG00000005463/ENSPREG00000003121/ENSPREG00000008410/ENSPREG00000002585/ENSPREG00000013315/ENSPREG00000016523/ENSPREG00000016312/ENSPREG00000023076/ENSPREG00000005185/ENSPREG00000017977/ENSPREG00000001224/ENSPREG00000002370/ENSPREG00000009493/ENSPREG00000018231/ENSPREG00000001908/ENSPREG00000021275/ENSPREG00000006028/ENSPREG00000010997/ENSPREG00000012543/ENSPREG00000004150/ENSPREG00000005590/ENSPREG00000014503/ENSPREG00000011179/ENSPREG00000009775/ENSPREG00000019675/ENSPREG00000012528/ENSPREG00000012550/ENSPREG00000016789/ENSPREG00000010051/ENSPREG00000012500/ENSPREG00000007903/ENSPREG00000018352/ENSPREG00000014206/ENSPREG00000019165/ENSPREG00000011314/ENSPREG00000022512/ENSPREG00000017408/ENSPREG00000015288/ENSPREG00000020231/ENSPREG00000006834/ENSPREG00000020595/ENSPREG00000008274/ENSPREG00000014100/ENSPREG00000019952/ENSPREG00000018426/ENSPREG00000015859/ENSPREG00000009791/ENSPREG00000013129/ENSPREG00000021927/ENSPREG00000004300/ENSPREG00000005315/ENSPREG00000015428/ENSPREG00000014698/ENSPREG00000003829/ENSPREG00000020189/ENSPREG00000021917/ENSPREG00000021333/ENSPREG00000007778/ENSPREG00000006590/ENSPREG00000011954/ENSPREG00000002257/ENSPREG00000017655/ENSPREG00000015245/ENSPREG00000006779/ENSPREG00000001563/ENSPREG00000009666/ENSPREG00000014141/ENSPREG00000009745/ENSPREG00000018698/ENSPREG00000021025/ENSPREG00000018707/ENSPREG00000019661/ENSPREG00000008917/ENSPREG00000017204/ENSPREG00000014773/ENSPREG00000010832/ENSPREG00000019665/ENSPREG00000022222/ENSPREG00000023130/ENSPREG00000012699/ENSPREG00000022933/ENSPREG00000011541/ENSPREG00000003161/ENSPREG00000017709/ENSPREG00000022413/ENSPREG00000009677/ENSPREG00000011082/ENSPREG00000002029/ENSPREG00000007340/ENSPREG00000003604/ENSPREG00000009354/ENSPREG00000007360/ENSPREG00000015236/ENSPREG00000015301/ENSPREG00000002278/ENSPREG00000008285/ENSPREG00000019048/ENSPREG00000011222/ENSPREG00000009618/ENSPREG00000006244/ENSPREG00000002124/ENSPREG00000001690/ENSPREG00000009929/ENSPREG00000017121/ENSPREG00000011139/ENSPREG00000009610/ENSPREG00000011284/ENSPREG00000004984/ENSPREG00000014772/ENSPREG00000016993/ENSPREG00000009607/ENSPREG00000022386/ENSPREG00000020661/ENSPREG00000019970/ENSPREG00000012330/ENSPREG00000002327/ENSPREG00000010790/ENSPREG00000007848/ENSPREG00000015114/ENSPREG00000022836/ENSPREG00000011322/ENSPREG00000005173/ENSPREG00000023048/ENSPREG00000004018/ENSPREG00000008798/ENSPREG00000009248/ENSPREG00000020926/ENSPREG00000015389/ENSPREG00000011339/ENSPREG00000005423/ENSPREG00000008676/ENSPREG00000009089/ENSPREG00000020147/ENSPREG00000013491/ENSPREG00000000778/ENSPREG00000021689/ENSPREG00000002362/ENSPREG00000016425/ENSPREG00000013631/ENSPREG00000002967/ENSPREG00000015338/ENSPREG00000012757/ENSPREG00000019297/ENSPREG00000017751/ENSPREG00000008436/ENSPREG00000018540/ENSPREG00000015059/ENSPREG00000020763/ENSPREG00000016489/ENSPREG00000004461/ENSPREG00000021213/ENSPREG00000013118/ENSPREG00000020818/ENSPREG00000020410/ENSPREG00000005041/ENSPREG00000004459/ENSPREG00000009749/ENSPREG00000004632/ENSPREG00000013653/ENSPREG00000022336/ENSPREG00000021256/ENSPREG00000006668/ENSPREG00000014079/ENSPREG00000012251/ENSPREG00000002380/ENSPREG00000022393/ENSPREG00000016937/ENSPREG00000022932/ENSPREG00000014506/ENSPREG00000023226/ENSPREG00000015582/ENSPREG00000015155/ENSPREG00000005687/ENSPREG00000021150/ENSPREG00000013078/ENSPREG00000021744/ENSPREG00000021425/ENSPREG00000001330/ENSPREG00000003561/ENSPREG00000014672/ENSPREG00000006193/ENSPREG00000015996/ENSPREG00000018823/ENSPREG00000015203/ENSPREG00000001419/ENSPREG00000007852/ENSPREG00000016307/ENSPREG00000004335/ENSPREG00000015073/ENSPREG00000008915/ENSPREG00000017113/ENSPREG00000017617/ENSPREG00000016765/ENSPREG00000002215/ENSPREG00000017458/ENSPREG00000015391/ENSPREG00000007082/ENSPREG00000022957/ENSPREG00000013256/ENSPREG00000004560/ENSPREG00000005237/ENSPREG00000010157/ENSPREG00000015467/ENSPREG00000000452/ENSPREG00000009307/ENSPREG00000010745/ENSPREG00000020974/ENSPREG00000001094/ENSPREG00000000134/ENSPREG00000022695/ENSPREG00000000631/ENSPREG00000013162/ENSPREG00000015440/ENSPREG00000013733/ENSPREG00000018410/ENSPREG00000008562/ENSPREG00000019686/ENSPREG00000018815/ENSPREG00000019319/ENSPREG00000014502/ENSPREG00000011769/ENSPREG00000003815/ENSPREG00000007865/ENSPREG00000019630/ENSPREG00000020820/ENSPREG00000011036/ENSPREG00000002792/ENSPREG00000021545/ENSPREG00000004565/ENSPREG00000016861/ENSPREG00000014461/ENSPREG00000019680/ENSPREG00000009338/ENSPREG00000011331/ENSPREG00000021455/ENSPREG00000001482/ENSPREG00000009910/ENSPREG00000006662/ENSPREG00000019123/ENSPREG00000020380/ENSPREG00000009084/ENSPREG00000018599/ENSPREG00000010817/ENSPREG00000016174/ENSPREG00000008778/ENSPREG00000006550/ENSPREG00000007309/ENSPREG00000019287/ENSPREG00000011796/ENSPREG00000022710/ENSPREG00000012408/ENSPREG00000022731/ENSPREG00000010850/ENSPREG00000010398/ENSPREG00000016215/ENSPREG00000009091/ENSPREG00000004263/ENSPREG00000011940/ENSPREG00000011348/ENSPREG00000009555/ENSPREG00000021321/ENSPREG00000022213/ENSPREG00000022300/ENSPREG00000011953/ENSPREG00000015146/ENSPREG00000004250/ENSPREG00000015770/ENSPREG00000000089/ENSPREG00000007793/ENSPREG00000014612/ENSPREG00000017070/ENSPREG00000012430/ENSPREG00000011736/ENSPREG00000016757/ENSPREG00000004302/ENSPREG00000006253/ENSPREG00000018775/ENSPREG00000004711/ENSPREG00000015928/ENSPREG00000007441/ENSPREG00000015672/ENSPREG00000000980/ENSPREG00000020658/ENSPREG00000017550/ENSPREG00000002962/ENSPREG00000015791/ENSPREG00000007423/ENSPREG00000022747/ENSPREG00000017873/ENSPREG00000022000/ENSPREG00000021215/ENSPREG00000015925/ENSPREG00000014992/ENSPREG00000010543/ENSPREG00000022344/ENSPREG00000005900/ENSPREG00000004312/ENSPREG00000004636/ENSPREG00000011567/ENSPREG00000014608/ENSPREG00000020504/ENSPREG00000016294/ENSPREG00000000279/ENSPREG00000011302/ENSPREG00000000588/ENSPREG00000023062/ENSPREG00000009905/ENSPREG00000010589/ENSPREG00000000819/ENSPREG00000013460/ENSPREG00000022805/ENSPREG00000018477/ENSPREG00000015157/ENSPREG00000015399/ENSPREG00000011946/ENSPREG00000007744/ENSPREG00000000727/ENSPREG00000008240/ENSPREG00000015151/ENSPREG00000006354/ENSPREG00000016104/ENSPREG00000021811/ENSPREG00000006611/ENSPREG00000019070/ENSPREG00000001286/ENSPREG00000013171/ENSPREG00000005457/ENSPREG00000020789/ENSPREG00000018185/ENSPREG00000006639/ENSPREG00000008273/ENSPREG00000002144/ENSPREG00000017657/ENSPREG00000000375/ENSPREG00000015074/ENSPREG00000017759/ENSPREG00000009970/ENSPREG00000018652/ENSPREG00000023123/ENSPREG00000019505/ENSPREG00000021825/ENSPREG00000022454/ENSPREG00000015376/ENSPREG00000006065/ENSPREG00000012466/ENSPREG00000019745/ENSPREG00000008141/ENSPREG00000006956/ENSPREG00000018891/ENSPREG00000010585/ENSPREG00000022420/ENSPREG00000015048/ENSPREG00000010793/ENSPREG00000008897/ENSPREG00000012394/ENSPREG00000013110/ENSPREG00000007468/ENSPREG00000020432/ENSPREG00000009350/ENSPREG00000009469/ENSPREG00000020953/ENSPREG00000011776/ENSPREG00000023083/ENSPREG00000001638/ENSPREG00000007496/ENSPREG00000003053/ENSPREG00000004576/ENSPREG00000022877/ENSPREG00000012365/ENSPREG00000009239/ENSPREG00000020099/ENSPREG00000010125/ENSPREG00000017699/ENSPREG00000017770/ENSPREG00000020271/ENSPREG00000009363/ENSPREG00000006781/ENSPREG00000001799/ENSPREG00000007013/ENSPREG00000018631/ENSPREG00000009747/ENSPREG00000010674/ENSPREG00000000954/ENSPREG00000009630/ENSPREG00000011358/ENSPREG00000013046/ENSPREG00000008293/ENSPREG00000018317/ENSPREG00000021856/ENSPREG00000023222/ENSPREG00000019808/ENSPREG00000002053/ENSPREG00000008737/ENSPREG00000020515/ENSPREG00000021756/ENSPREG00000017893/ENSPREG00000022808/ENSPREG00000011345/ENSPREG00000014809/ENSPREG00000023011/ENSPREG00000002071/ENSPREG00000022200/ENSPREG00000000189/ENSPREG00000001857/ENSPREG00000016460/ENSPREG00000004333/ENSPREG00000015012/ENSPREG00000000958/ENSPREG00000002971/ENSPREG00000005510/ENSPREG00000009016/ENSPREG00000005229/ENSPREG00000001810/ENSPREG00000004360/ENSPREG00000001928/ENSPREG00000015532/ENSPREG00000015956/ENSPREG00000003610/ENSPREG00000015772/ENSPREG00000003133/ENSPREG00000022590/ENSPREG00000016036/ENSPREG00000019283/ENSPREG00000008558/ENSPREG00000019901/ENSPREG00000014532/ENSPREG00000019676/ENSPREG00000006393/ENSPREG00000017910/ENSPREG00000000956/ENSPREG00000002771/ENSPREG00000007218/ENSPREG00000018764/ENSPREG00000019225/ENSPREG00000015724/ENSPREG00000016532/ENSPREG00000018531/ENSPREG00000008338/ENSPREG00000000802/ENSPREG00000016483/ENSPREG00000005608/ENSPREG00000009816/ENSPREG00000007703/ENSPREG00000001336/ENSPREG00000010965/ENSPREG00000003967/ENSPREG00000002203/ENSPREG00000011102/ENSPREG00000012767/ENSPREG00000002540/ENSPREG00000002294/ENSPREG00000008228/ENSPREG00000009412/ENSPREG00000014336/ENSPREG00000022687/ENSPREG00000014490/ENSPREG00000004105/ENSPREG00000009286/ENSPREG00000022708/ENSPREG00000000212/ENSPREG00000020451/ENSPREG00000004395/ENSPREG00000005893/ENSPREG00000013348/ENSPREG00000018525/ENSPREG00000010824/ENSPREG00000017488/ENSPREG00000019713/ENSPREG00000017711/ENSPREG00000008369/ENSPREG00000005291/ENSPREG00000000181/ENSPREG00000004867/ENSPREG00000003558/ENSPREG00000003960/ENSPREG00000003963/ENSPREG00000011365/ENSPREG00000017093/ENSPREG00000005588/ENSPREG00000020891/ENSPREG00000004187/ENSPREG00000009885/ENSPREG00000017242/ENSPREG00000011944/ENSPREG00000001029/ENSPREG00000015635/ENSPREG00000019049/ENSPREG00000001983/ENSPREG00000022596/ENSPREG00000007678/ENSPREG00000001587/ENSPREG00000020970/ENSPREG00000016663/ENSPREG00000022570/ENSPREG00000018609/ENSPREG00000010047/ENSPREG00000013539/ENSPREG00000006553/ENSPREG00000006571/ENSPREG00000000857/ENSPREG00000013538/ENSPREG00000009415/ENSPREG00000003345/ENSPREG00000014824/ENSPREG00000019273/ENSPREG00000020123/ENSPREG00000003003/ENSPREG00000016369/ENSPREG00000010318/ENSPREG00000007620/ENSPREG00000012361/ENSPREG00000009669/ENSPREG00000022278/ENSPREG00000000343/ENSPREG00000011854/ENSPREG00000006874/ENSPREG00000005336/ENSPREG00000000681/ENSPREG00000020399/ENSPREG00000001918/ENSPREG00000004391/ENSPREG00000014043/ENSPREG00000009173/ENSPREG00000010808/ENSPREG00000018582/ENSPREG00000016255/ENSPREG00000016311/ENSPREG00000003502/ENSPREG00000004149/ENSPREG00000009287/ENSPREG00000007092/ENSPREG00000008027/ENSPREG00000020583/ENSPREG00000012615/ENSPREG00000005420/ENSPREG00000012620/ENSPREG00000002204/ENSPREG00000016073/ENSPREG00000017741/ENSPREG00000015578/ENSPREG00000019855/ENSPREG00000009830/ENSPREG00000002891/ENSPREG00000008622/ENSPREG00000020711/ENSPREG00000003437/ENSPREG00000011931/ENSPREG00000016331/ENSPREG00000010742/ENSPREG00000016974/ENSPREG00000017839/ENSPREG00000006425/ENSPREG00000009071/ENSPREG00000015899/ENSPREG00000002675/ENSPREG00000018632/ENSPREG00000000162/ENSPREG00000013094/ENSPREG00000023195/ENSPREG00000013344/ENSPREG00000015988/ENSPREG00000007756/ENSPREG00000003820/ENSPREG00000007693/ENSPREG00000007039/ENSPREG00000020771/ENSPREG00000000704/ENSPREG00000022353/ENSPREG00000001415/ENSPREG00000003150/ENSPREG00000002932/ENSPREG00000019192/ENSPREG00000022447/ENSPREG00000000900/ENSPREG00000010928/ENSPREG00000010127/ENSPREG00000017613/ENSPREG00000005086/ENSPREG00000015764/ENSPREG00000005614/ENSPREG00000014790/ENSPREG00000006810/ENSPREG00000011027/ENSPREG00000001790/ENSPREG00000020450/ENSPREG00000022109/ENSPREG00000016362/ENSPREG00000014150/ENSPREG00000012388/ENSPREG00000006035/ENSPREG00000020906/ENSPREG00000003290/ENSPREG00000001968/ENSPREG00000018217/ENSPREG00000018400/ENSPREG00000019780/ENSPREG00000021727/ENSPREG00000007919/ENSPREG00000014668/ENSPREG00000020747/ENSPREG00000017525/ENSPREG00000010978/ENSPREG00000003630/ENSPREG00000001103/ENSPREG00000002749/ENSPREG00000020218/ENSPREG00000018831/ENSPREG00000012860/ENSPREG00000019002/ENSPREG00000015991/ENSPREG00000008157/ENSPREG00000018926/ENSPREG00000017641/ENSPREG00000016525/ENSPREG00000014823/ENSPREG00000010347/ENSPREG00000008550/ENSPREG00000020126/ENSPREG00000019095/ENSPREG00000009537/ENSPREG00000010460/ENSPREG00000000528/ENSPREG00000017575/ENSPREG00000002598/ENSPREG00000008024/ENSPREG00000002884/ENSPREG00000012276/ENSPREG00000003411/ENSPREG00000020726/ENSPREG00000017713/ENSPREG00000022950/ENSPREG00000009177/ENSPREG00000022527/ENSPREG00000007579/ENSPREG00000011881/ENSPREG00000019518/ENSPREG00000009192/ENSPREG00000010274/ENSPREG00000020729/ENSPREG00000004787/ENSPREG00000018664/ENSPREG00000018178/ENSPREG00000005065/ENSPREG00000021880/ENSPREG00000008883/ENSPREG00000003665/ENSPREG00000001294/ENSPREG00000014555/ENSPREG00000007076/ENSPREG00000016136/ENSPREG00000006582/ENSPREG00000001233/ENSPREG00000005355/ENSPREG00000010771/ENSPREG00000020589/ENSPREG00000007053/ENSPREG00000013242/ENSPREG00000010858/ENSPREG00000000238/ENSPREG00000006420/ENSPREG00000020999/ENSPREG00000012701/ENSPREG00000019203/ENSPREG00000021906/ENSPREG00000020842/ENSPREG00000015354/ENSPREG00000004736/ENSPREG00000008887/ENSPREG00000021889/ENSPREG00000020238/ENSPREG00000020121/ENSPREG00000022506/ENSPREG00000019331/ENSPREG00000003493/ENSPREG00000015415/ENSPREG00000018648/ENSPREG00000004412/ENSPREG00000019243/ENSPREG00000000217/ENSPREG00000015735/ENSPREG00000006734/ENSPREG00000006089/ENSPREG00000015076/ENSPREG00000020784/ENSPREG00000011159/ENSPREG00000009497/ENSPREG00000014165/ENSPREG00000023009/ENSPREG00000020144/ENSPREG00000019515/ENSPREG00000007168/ENSPREG00000007587/ENSPREG00000004722/ENSPREG00000002219/ENSPREG00000007682/ENSPREG00000011108/ENSPREG00000019374/ENSPREG00000014744/ENSPREG00000003147/ENSPREG00000019278/ENSPREG00000021620/ENSPREG00000005418/ENSPREG00000002834/ENSPREG00000020849/ENSPREG00000011786/ENSPREG00000022867/ENSPREG00000022823/ENSPREG00000015143/ENSPREG00000013831/ENSPREG00000015490/ENSPREG00000010443/ENSPREG00000021152/ENSPREG00000021603/ENSPREG00000000609/ENSPREG00000022193/ENSPREG00000003868/ENSPREG00000017285/ENSPREG00000006981/ENSPREG00000009060/ENSPREG00000002851/ENSPREG00000016554/ENSPREG00000023229/ENSPREG00000023230/ENSPREG00000013038/ENSPREG00000021765/ENSPREG00000019965/ENSPREG00000016334/ENSPREG00000006078/ENSPREG00000015414/ENSPREG00000003442/ENSPREG00000010187/ENSPREG00000017215/ENSPREG00000019985/ENSPREG00000017900/ENSPREG00000022843/ENSPREG00000002626/ENSPREG00000005289/ENSPREG00000023056/ENSPREG00000002655/ENSPREG00000021224/ENSPREG00000007115/ENSPREG00000018838/ENSPREG00000022428/ENSPREG00000018845/ENSPREG00000007220/ENSPREG00000018283/ENSPREG00000017608/ENSPREG00000002212/ENSPREG00000004944/ENSPREG00000015065/ENSPREG00000016766/ENSPREG00000000312/ENSPREG00000006112/ENSPREG00000016639/ENSPREG00000009142/ENSPREG00000021401/ENSPREG00000014854/ENSPREG00000010200/ENSPREG00000002472/ENSPREG00000008592/ENSPREG00000015786/ENSPREG00000002536/ENSPREG00000002006/ENSPREG00000018867/ENSPREG00000001738/ENSPREG00000021797/ENSPREG00000009332/ENSPREG00000020619/ENSPREG00000003595/ENSPREG00000012093/ENSPREG00000011758/ENSPREG00000014947/ENSPREG00000006918/ENSPREG00000020969/ENSPREG00000000313/ENSPREG00000014280/ENSPREG00000010078/ENSPREG00000019947/ENSPREG00000006378/ENSPREG00000011544/ENSPREG00000012267/ENSPREG00000009185/ENSPREG00000021867/ENSPREG00000018397/ENSPREG00000022223/ENSPREG00000008848/ENSPREG00000004715/ENSPREG00000020482/ENSPREG00000016686/ENSPREG00000000107/ENSPREG00000007668/ENSPREG00000010921/ENSPREG00000011471/ENSPREG00000009864/ENSPREG00000021638/ENSPREG00000010066/ENSPREG00000004477/ENSPREG00000012373/ENSPREG00000006183/ENSPREG00000003369/ENSPREG00000011250/ENSPREG00000015541/ENSPREG00000008818/ENSPREG00000010471/ENSPREG00000021294/ENSPREG00000017120
## GO:0030522 intracellular receptor signaling pathway                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                         ENSPREG00000018748/ENSPREG00000008698/ENSPREG00000013686/ENSPREG00000021486/ENSPREG00000009731/ENSPREG00000020437/ENSPREG00000001838/ENSPREG00000013209/ENSPREG00000009356/ENSPREG00000001562/ENSPREG00000004255/ENSPREG00000022630/ENSPREG00000011546
## GO:0003094 glomerular filtration                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                              ENSPREG00000018284/ENSPREG00000023226/ENSPREG00000012932/ENSPREG00000010531/ENSPREG00000001812/ENSPREG00000003411/ENSPREG00000013106
## GO:0009887 animal organ morphogenesis                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                      ENSPREG00000014489/ENSPREG00000008317/ENSPREG00000013601/ENSPREG00000021454/ENSPREG00000014440/ENSPREG00000020145/ENSPREG00000004048/ENSPREG00000018009
## GO:0045296 cadherin binding                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                      ENSPREG00000019281/ENSPREG00000013118/ENSPREG00000000452/ENSPREG00000006377/ENSPREG00000004309/ENSPREG00000009171
## GO:0045104 intermediate filament cytoskeleton organization                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                              ENSPREG00000022366/ENSPREG00000014518/ENSPREG00000006848/ENSPREG00000014532/ENSPREG00000015483/ENSPREG00000006810/ENSPREG00000019095/ENSPREG00000006918/ENSPREG00000014510
## GO:0048484 enteric nervous system development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000022019/ENSPREG00000017424/ENSPREG00000002079/ENSPREG00000000133/ENSPREG00000022300/ENSPREG00000018715/ENSPREG00000016745/ENSPREG00000002410/ENSPREG00000002978/ENSPREG00000020582
## GO:0021549 cerebellum development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                          ENSPREG00000017475/ENSPREG00000013729/ENSPREG00000018368/ENSPREG00000013353/ENSPREG00000012091/ENSPREG00000008463/ENSPREG00000014912/ENSPREG00000020145
## GO:0006384 transcription initiation from RNA polymerase III promoter                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                   ENSPREG00000010651/ENSPREG00000000142/ENSPREG00000021756/ENSPREG00000008487
## GO:0032422 purine-rich negative regulatory element binding                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                             ENSPREG00000013084/ENSPREG00000019200/ENSPREG00000012322/ENSPREG00000015491
##                                                                      Count
## GO:0060294 cilium movement involved in cell motility                     6
## GO:0007275 multicellular organism development                          142
## GO:0030837 negative regulation of actin filament polymerization          6
## GO:0006596 polyamine biosynthetic process                                5
## GO:0030111 regulation of Wnt signaling pathway                           5
## GO:0005515 protein binding                                             858
## GO:0030522 intracellular receptor signaling pathway                     13
## GO:0003094 glomerular filtration                                         7
## GO:0009887 animal organ morphogenesis                                    8
## GO:0045296 cadherin binding                                              6
## GO:0045104 intermediate filament cytoskeleton organization               9
## GO:0048484 enteric nervous system development                           10
## GO:0021549 cerebellum development                                        8
## GO:0006384 transcription initiation from RNA polymerase III promoter     4
## GO:0032422 purine-rich negative regulatory element binding               4
CvGunion <- union(CvG_up,CvG_dn)

c_union <- enricher(gene = CvGunion, universe = CvG_bg, minGSSize = 5,  maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_union,15)
##                                                                                                                              ID
## GO:0046716 muscle cell cellular homeostasis                                         GO:0046716 muscle cell cellular homeostasis
## GO:0060294 cilium movement involved in cell motility                       GO:0060294 cilium movement involved in cell motility
## GO:1905606 regulation of presynapse assembly                                       GO:1905606 regulation of presynapse assembly
## GO:0007275 multicellular organism development                                     GO:0007275 multicellular organism development
## GO:0009887 animal organ morphogenesis                                                     GO:0009887 animal organ morphogenesis
## GO:0006355 regulation of transcription, DNA-templated                     GO:0006355 regulation of transcription, DNA-templated
## GO:0030522 intracellular receptor signaling pathway                         GO:0030522 intracellular receptor signaling pathway
## GO:0004879 nuclear receptor activity                                                       GO:0004879 nuclear receptor activity
## GO:0003677 DNA binding                                                                                   GO:0003677 DNA binding
## GO:0030837 negative regulation of actin filament polymerization GO:0030837 negative regulation of actin filament polymerization
## GO:0007409 axonogenesis                                                                                 GO:0007409 axonogenesis
## GO:0032422 purine-rich negative regulatory element binding           GO:0032422 purine-rich negative regulatory element binding
## GO:0003682 chromatin binding                                                                       GO:0003682 chromatin binding
## GO:0022625 cytosolic large ribosomal subunit                                       GO:0022625 cytosolic large ribosomal subunit
## GO:0030155 regulation of cell adhesion                                                   GO:0030155 regulation of cell adhesion
##                                                                                                                     Description
## GO:0046716 muscle cell cellular homeostasis                                         GO:0046716 muscle cell cellular homeostasis
## GO:0060294 cilium movement involved in cell motility                       GO:0060294 cilium movement involved in cell motility
## GO:1905606 regulation of presynapse assembly                                       GO:1905606 regulation of presynapse assembly
## GO:0007275 multicellular organism development                                     GO:0007275 multicellular organism development
## GO:0009887 animal organ morphogenesis                                                     GO:0009887 animal organ morphogenesis
## GO:0006355 regulation of transcription, DNA-templated                     GO:0006355 regulation of transcription, DNA-templated
## GO:0030522 intracellular receptor signaling pathway                         GO:0030522 intracellular receptor signaling pathway
## GO:0004879 nuclear receptor activity                                                       GO:0004879 nuclear receptor activity
## GO:0003677 DNA binding                                                                                   GO:0003677 DNA binding
## GO:0030837 negative regulation of actin filament polymerization GO:0030837 negative regulation of actin filament polymerization
## GO:0007409 axonogenesis                                                                                 GO:0007409 axonogenesis
## GO:0032422 purine-rich negative regulatory element binding           GO:0032422 purine-rich negative regulatory element binding
## GO:0003682 chromatin binding                                                                       GO:0003682 chromatin binding
## GO:0022625 cytosolic large ribosomal subunit                                       GO:0022625 cytosolic large ribosomal subunit
## GO:0030155 regulation of cell adhesion                                                   GO:0030155 regulation of cell adhesion
##                                                                 GeneRatio
## GO:0046716 muscle cell cellular homeostasis                        7/6129
## GO:0060294 cilium movement involved in cell motility               7/6129
## GO:1905606 regulation of presynapse assembly                       7/6129
## GO:0007275 multicellular organism development                    196/6129
## GO:0009887 animal organ morphogenesis                             11/6129
## GO:0006355 regulation of transcription, DNA-templated            339/6129
## GO:0030522 intracellular receptor signaling pathway               17/6129
## GO:0004879 nuclear receptor activity                              22/6129
## GO:0003677 DNA binding                                           428/6129
## GO:0030837 negative regulation of actin filament polymerization    7/6129
## GO:0007409 axonogenesis                                           22/6129
## GO:0032422 purine-rich negative regulatory element binding         5/6129
## GO:0003682 chromatin binding                                      23/6129
## GO:0022625 cytosolic large ribosomal subunit                       6/6129
## GO:0030155 regulation of cell adhesion                             6/6129
##                                                                    BgRatio
## GO:0046716 muscle cell cellular homeostasis                        7/18074
## GO:0060294 cilium movement involved in cell motility               7/18074
## GO:1905606 regulation of presynapse assembly                       7/18074
## GO:0007275 multicellular organism development                    480/18074
## GO:0009887 animal organ morphogenesis                             14/18074
## GO:0006355 regulation of transcription, DNA-templated            876/18074
## GO:0030522 intracellular receptor signaling pathway               27/18074
## GO:0004879 nuclear receptor activity                              38/18074
## GO:0003677 DNA binding                                          1132/18074
## GO:0030837 negative regulation of actin filament polymerization    8/18074
## GO:0007409 axonogenesis                                           39/18074
## GO:0032422 purine-rich negative regulatory element binding         5/18074
## GO:0003682 chromatin binding                                      43/18074
## GO:0022625 cytosolic large ribosomal subunit                       7/18074
## GO:0030155 regulation of cell adhesion                             7/18074
##                                                                       pvalue
## GO:0046716 muscle cell cellular homeostasis                     0.0005144741
## GO:0060294 cilium movement involved in cell motility            0.0005144741
## GO:1905606 regulation of presynapse assembly                    0.0005144741
## GO:0007275 multicellular organism development                   0.0007919458
## GO:0009887 animal organ morphogenesis                           0.0008122831
## GO:0006355 regulation of transcription, DNA-templated           0.0013235115
## GO:0030522 intracellular receptor signaling pathway             0.0018930682
## GO:0004879 nuclear receptor activity                            0.0020545323
## GO:0003677 DNA binding                                          0.0024784353
## GO:0030837 negative regulation of actin filament polymerization 0.0028954865
## GO:0007409 axonogenesis                                         0.0032165449
## GO:0032422 purine-rich negative regulatory element binding      0.0044792805
## GO:0003682 chromatin binding                                    0.0063749660
## GO:0022625 cytosolic large ribosomal subunit                    0.0075400744
## GO:0030155 regulation of cell adhesion                          0.0075400744
##                                                                  p.adjust
## GO:0046716 muscle cell cellular homeostasis                     0.2852738
## GO:0060294 cilium movement involved in cell motility            0.2852738
## GO:1905606 regulation of presynapse assembly                    0.2852738
## GO:0007275 multicellular organism development                   0.2852738
## GO:0009887 animal organ morphogenesis                           0.2852738
## GO:0006355 regulation of transcription, DNA-templated           0.3873477
## GO:0030522 intracellular receptor signaling pathway             0.4509698
## GO:0004879 nuclear receptor activity                            0.4509698
## GO:0003677 DNA binding                                          0.4835703
## GO:0030837 negative regulation of actin filament polymerization 0.5084474
## GO:0007409 axonogenesis                                         0.5134775
## GO:0032422 purine-rich negative regulatory element binding      0.6554680
## GO:0003682 chromatin binding                                    0.7617862
## GO:0022625 cytosolic large ribosomal subunit                    0.7617862
## GO:0030155 regulation of cell adhesion                          0.7617862
##                                                                    qvalue
## GO:0046716 muscle cell cellular homeostasis                     0.2850686
## GO:0060294 cilium movement involved in cell motility            0.2850686
## GO:1905606 regulation of presynapse assembly                    0.2850686
## GO:0007275 multicellular organism development                   0.2850686
## GO:0009887 animal organ morphogenesis                           0.2850686
## GO:0006355 regulation of transcription, DNA-templated           0.3870691
## GO:0030522 intracellular receptor signaling pathway             0.4506454
## GO:0004879 nuclear receptor activity                            0.4506454
## GO:0003677 DNA binding                                          0.4832224
## GO:0030837 negative regulation of actin filament polymerization 0.5080817
## GO:0007409 axonogenesis                                         0.5131082
## GO:0032422 purine-rich negative regulatory element binding      0.6549965
## GO:0003682 chromatin binding                                    0.7612382
## GO:0022625 cytosolic large ribosomal subunit                    0.7612382
## GO:0030155 regulation of cell adhesion                          0.7612382
##                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                              geneID
## GO:0046716 muscle cell cellular homeostasis                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                    ENSPREG00000009411/ENSPREG00000019794/ENSPREG00000020904/ENSPREG00000012706/ENSPREG00000002855/ENSPREG00000004187/ENSPREG00000020962
## GO:0060294 cilium movement involved in cell motility                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000000366/ENSPREG00000009719/ENSPREG00000009761/ENSPREG00000012200/ENSPREG00000009128/ENSPREG00000020731/ENSPREG00000011030
## GO:1905606 regulation of presynapse assembly                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                   ENSPREG00000017257/ENSPREG00000008887/ENSPREG00000019248/ENSPREG00000019208/ENSPREG00000008897/ENSPREG00000002212/ENSPREG00000010471
## GO:0007275 multicellular organism development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000006479/ENSPREG00000004660/ENSPREG00000021420/ENSPREG00000009198/ENSPREG00000014369/ENSPREG00000005368/ENSPREG00000005374/ENSPREG00000011115/ENSPREG00000010035/ENSPREG00000007669/ENSPREG00000021106/ENSPREG00000011756/ENSPREG00000006777/ENSPREG00000021725/ENSPREG00000020011/ENSPREG00000006396/ENSPREG00000001810/ENSPREG00000005385/ENSPREG00000001804/ENSPREG00000000557/ENSPREG00000020203/ENSPREG00000004862/ENSPREG00000020178/ENSPREG00000014079/ENSPREG00000021021/ENSPREG00000015614/ENSPREG00000004689/ENSPREG00000018739/ENSPREG00000021322/ENSPREG00000013196/ENSPREG00000013812/ENSPREG00000017782/ENSPREG00000021337/ENSPREG00000005821/ENSPREG00000010656/ENSPREG00000016605/ENSPREG00000012168/ENSPREG00000001888/ENSPREG00000000691/ENSPREG00000019836/ENSPREG00000023186/ENSPREG00000009681/ENSPREG00000022277/ENSPREG00000000563/ENSPREG00000014049/ENSPREG00000012582/ENSPREG00000000568/ENSPREG00000006008/ENSPREG00000017347/ENSPREG00000021010/ENSPREG00000009731/ENSPREG00000019321/ENSPREG00000016519/ENSPREG00000008801/ENSPREG00000016234/ENSPREG00000009154/ENSPREG00000017409/ENSPREG00000008761/ENSPREG00000006469/ENSPREG00000008357/ENSPREG00000003672/ENSPREG00000004813/ENSPREG00000006787/ENSPREG00000016476/ENSPREG00000002914/ENSPREG00000015884/ENSPREG00000006276/ENSPREG00000002117/ENSPREG00000011561/ENSPREG00000009183/ENSPREG00000007342/ENSPREG00000000683/ENSPREG00000002123/ENSPREG00000003235/ENSPREG00000000612/ENSPREG00000021717/ENSPREG00000019762/ENSPREG00000020332/ENSPREG00000017582/ENSPREG00000021719/ENSPREG00000018360/ENSPREG00000013766/ENSPREG00000003001/ENSPREG00000009481/ENSPREG00000016378/ENSPREG00000010783/ENSPREG00000003088/ENSPREG00000022983/ENSPREG00000008377/ENSPREG00000004667/ENSPREG00000009349/ENSPREG00000014773/ENSPREG00000010797/ENSPREG00000001340/ENSPREG00000017475/ENSPREG00000005101/ENSPREG00000000133/ENSPREG00000010790/ENSPREG00000008022/ENSPREG00000005343/ENSPREG00000006760/ENSPREG00000002673/ENSPREG00000001346/ENSPREG00000012541/ENSPREG00000011913/ENSPREG00000015465/ENSPREG00000013058/ENSPREG00000019287/ENSPREG00000013353/ENSPREG00000000532/ENSPREG00000021227/ENSPREG00000006758/ENSPREG00000006190/ENSPREG00000007900/ENSPREG00000012697/ENSPREG00000021274/ENSPREG00000020658/ENSPREG00000006606/ENSPREG00000015499/ENSPREG00000018135/ENSPREG00000001072/ENSPREG00000008300/ENSPREG00000018299/ENSPREG00000013601/ENSPREG00000008696/ENSPREG00000018652/ENSPREG00000011038/ENSPREG00000020206/ENSPREG00000010793/ENSPREG00000017901/ENSPREG00000006772/ENSPREG00000009363/ENSPREG00000015450/ENSPREG00000002053/ENSPREG00000013209/ENSPREG00000023206/ENSPREG00000001397/ENSPREG00000009356/ENSPREG00000004970/ENSPREG00000017077/ENSPREG00000005380/ENSPREG00000006819/ENSPREG00000011441/ENSPREG00000021949/ENSPREG00000006631/ENSPREG00000008297/ENSPREG00000019085/ENSPREG00000020667/ENSPREG00000002795/ENSPREG00000017001/ENSPREG00000001918/ENSPREG00000013048/ENSPREG00000020340/ENSPREG00000000163/ENSPREG00000003379/ENSPREG00000006929/ENSPREG00000021144/ENSPREG00000011620/ENSPREG00000008016/ENSPREG00000012105/ENSPREG00000015326/ENSPREG00000008325/ENSPREG00000011721/ENSPREG00000011089/ENSPREG00000013684/ENSPREG00000014000/ENSPREG00000002598/ENSPREG00000023212/ENSPREG00000020538/ENSPREG00000001265/ENSPREG00000022538/ENSPREG00000015189/ENSPREG00000013636/ENSPREG00000003992/ENSPREG00000006101/ENSPREG00000005482/ENSPREG00000003325/ENSPREG00000014120/ENSPREG00000002679/ENSPREG00000019531/ENSPREG00000006981/ENSPREG00000021597/ENSPREG00000004436/ENSPREG00000019962/ENSPREG00000018009/ENSPREG00000007418/ENSPREG00000017669/ENSPREG00000014038/ENSPREG00000020848/ENSPREG00000003491/ENSPREG00000009171/ENSPREG00000023233/ENSPREG00000001369/ENSPREG00000006716/ENSPREG00000010959/ENSPREG00000002135
## GO:0009887 animal organ morphogenesis                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                              ENSPREG00000001620/ENSPREG00000013898/ENSPREG00000006008/ENSPREG00000014489/ENSPREG00000008317/ENSPREG00000013601/ENSPREG00000021454/ENSPREG00000014440/ENSPREG00000020145/ENSPREG00000004048/ENSPREG00000018009
## GO:0006355 regulation of transcription, DNA-templated                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                      ENSPREG00000022182/ENSPREG00000006479/ENSPREG00000004660/ENSPREG00000012138/ENSPREG00000021365/ENSPREG00000009198/ENSPREG00000005368/ENSPREG00000005374/ENSPREG00000012367/ENSPREG00000004029/ENSPREG00000011115/ENSPREG00000012663/ENSPREG00000006777/ENSPREG00000021725/ENSPREG00000018974/ENSPREG00000020011/ENSPREG00000009540/ENSPREG00000012965/ENSPREG00000006396/ENSPREG00000001810/ENSPREG00000001771/ENSPREG00000005385/ENSPREG00000012188/ENSPREG00000002057/ENSPREG00000000557/ENSPREG00000016872/ENSPREG00000019859/ENSPREG00000020203/ENSPREG00000020178/ENSPREG00000016918/ENSPREG00000022421/ENSPREG00000007159/ENSPREG00000015981/ENSPREG00000006450/ENSPREG00000021021/ENSPREG00000009977/ENSPREG00000019566/ENSPREG00000000662/ENSPREG00000019055/ENSPREG00000004689/ENSPREG00000015427/ENSPREG00000022772/ENSPREG00000023177/ENSPREG00000010182/ENSPREG00000013196/ENSPREG00000013812/ENSPREG00000000694/ENSPREG00000020853/ENSPREG00000010340/ENSPREG00000000792/ENSPREG00000013087/ENSPREG00000021337/ENSPREG00000005821/ENSPREG00000010656/ENSPREG00000011269/ENSPREG00000010804/ENSPREG00000012168/ENSPREG00000002999/ENSPREG00000007634/ENSPREG00000018925/ENSPREG00000019840/ENSPREG00000000691/ENSPREG00000019836/ENSPREG00000021173/ENSPREG00000023186/ENSPREG00000015542/ENSPREG00000010594/ENSPREG00000004185/ENSPREG00000008193/ENSPREG00000022470/ENSPREG00000009681/ENSPREG00000017805/ENSPREG00000014207/ENSPREG00000021778/ENSPREG00000007944/ENSPREG00000000563/ENSPREG00000014049/ENSPREG00000010877/ENSPREG00000015529/ENSPREG00000013420/ENSPREG00000012582/ENSPREG00000011959/ENSPREG00000017887/ENSPREG00000000568/ENSPREG00000011930/ENSPREG00000019537/ENSPREG00000013848/ENSPREG00000018196/ENSPREG00000009731/ENSPREG00000019321/ENSPREG00000016519/ENSPREG00000020502/ENSPREG00000016234/ENSPREG00000021553/ENSPREG00000003428/ENSPREG00000018909/ENSPREG00000003901/ENSPREG00000008761/ENSPREG00000019519/ENSPREG00000023202/ENSPREG00000020875/ENSPREG00000022614/ENSPREG00000005028/ENSPREG00000014025/ENSPREG00000018193/ENSPREG00000006787/ENSPREG00000012532/ENSPREG00000001758/ENSPREG00000014097/ENSPREG00000021437/ENSPREG00000008490/ENSPREG00000010581/ENSPREG00000023255/ENSPREG00000006111/ENSPREG00000019601/ENSPREG00000015884/ENSPREG00000018399/ENSPREG00000004655/ENSPREG00000006276/ENSPREG00000002510/ENSPREG00000018613/ENSPREG00000002117/ENSPREG00000016109/ENSPREG00000004444/ENSPREG00000023092/ENSPREG00000014446/ENSPREG00000008337/ENSPREG00000007342/ENSPREG00000000683/ENSPREG00000002123/ENSPREG00000010907/ENSPREG00000001824/ENSPREG00000005256/ENSPREG00000006142/ENSPREG00000021717/ENSPREG00000019762/ENSPREG00000018881/ENSPREG00000013623/ENSPREG00000014745/ENSPREG00000008785/ENSPREG00000018748/ENSPREG00000020332/ENSPREG00000011064/ENSPREG00000017582/ENSPREG00000021719/ENSPREG00000003743/ENSPREG00000021136/ENSPREG00000013766/ENSPREG00000022546/ENSPREG00000016676/ENSPREG00000018249/ENSPREG00000013315/ENSPREG00000003001/ENSPREG00000001543/ENSPREG00000014960/ENSPREG00000010783/ENSPREG00000008698/ENSPREG00000022983/ENSPREG00000008377/ENSPREG00000013995/ENSPREG00000001598/ENSPREG00000014513/ENSPREG00000013775/ENSPREG00000022267/ENSPREG00000010797/ENSPREG00000004647/ENSPREG00000001340/ENSPREG00000012699/ENSPREG00000003063/ENSPREG00000021875/ENSPREG00000017475/ENSPREG00000010086/ENSPREG00000011212/ENSPREG00000011922/ENSPREG00000004232/ENSPREG00000011677/ENSPREG00000013686/ENSPREG00000013067/ENSPREG00000022899/ENSPREG00000022906/ENSPREG00000022501/ENSPREG00000009351/ENSPREG00000018224/ENSPREG00000003447/ENSPREG00000005343/ENSPREG00000007592/ENSPREG00000017239/ENSPREG00000006760/ENSPREG00000021782/ENSPREG00000001346/ENSPREG00000005281/ENSPREG00000007997/ENSPREG00000022910/ENSPREG00000007429/ENSPREG00000005246/ENSPREG00000019546/ENSPREG00000012541/ENSPREG00000013386/ENSPREG00000001360/ENSPREG00000011913/ENSPREG00000016689/ENSPREG00000015465/ENSPREG00000013058/ENSPREG00000020458/ENSPREG00000013353/ENSPREG00000000532/ENSPREG00000011189/ENSPREG00000021227/ENSPREG00000011940/ENSPREG00000006758/ENSPREG00000013403/ENSPREG00000014467/ENSPREG00000007900/ENSPREG00000007793/ENSPREG00000017420/ENSPREG00000018379/ENSPREG00000006606/ENSPREG00000015499/ENSPREG00000011231/ENSPREG00000013828/ENSPREG00000020437/ENSPREG00000015916/ENSPREG00000014608/ENSPREG00000011080/ENSPREG00000022066/ENSPREG00000008300/ENSPREG00000013601/ENSPREG00000001229/ENSPREG00000016099/ENSPREG00000000511/ENSPREG00000006956/ENSPREG00000009598/ENSPREG00000008402/ENSPREG00000013840/ENSPREG00000017901/ENSPREG00000006772/ENSPREG00000009363/ENSPREG00000015450/ENSPREG00000001838/ENSPREG00000023222/ENSPREG00000013209/ENSPREG00000020804/ENSPREG00000010841/ENSPREG00000021982/ENSPREG00000000419/ENSPREG00000008918/ENSPREG00000023206/ENSPREG00000016508/ENSPREG00000016361/ENSPREG00000001397/ENSPREG00000009356/ENSPREG00000004970/ENSPREG00000015213/ENSPREG00000002018/ENSPREG00000017077/ENSPREG00000019823/ENSPREG00000016909/ENSPREG00000013445/ENSPREG00000008815/ENSPREG00000005380/ENSPREG00000006819/ENSPREG00000004558/ENSPREG00000011441/ENSPREG00000005893/ENSPREG00000015273/ENSPREG00000001562/ENSPREG00000006631/ENSPREG00000008297/ENSPREG00000002795/ENSPREG00000017001/ENSPREG00000004255/ENSPREG00000018558/ENSPREG00000013048/ENSPREG00000020340/ENSPREG00000005578/ENSPREG00000011918/ENSPREG00000006929/ENSPREG00000022851/ENSPREG00000011620/ENSPREG00000022410/ENSPREG00000019385/ENSPREG00000012105/ENSPREG00000015326/ENSPREG00000014440/ENSPREG00000012369/ENSPREG00000022630/ENSPREG00000004743/ENSPREG00000015826/ENSPREG00000018387/ENSPREG00000007919/ENSPREG00000011986/ENSPREG00000011721/ENSPREG00000005288/ENSPREG00000011089/ENSPREG00000014823/ENSPREG00000013684/ENSPREG00000017575/ENSPREG00000018453/ENSPREG00000023212/ENSPREG00000020538/ENSPREG00000022538/ENSPREG00000015189/ENSPREG00000017352/ENSPREG00000016928/ENSPREG00000004628/ENSPREG00000005784/ENSPREG00000019842/ENSPREG00000013636/ENSPREG00000006101/ENSPREG00000003325/ENSPREG00000019278/ENSPREG00000008832/ENSPREG00000010102/ENSPREG00000001997/ENSPREG00000019531/ENSPREG00000004404/ENSPREG00000022723/ENSPREG00000002851/ENSPREG00000007996/ENSPREG00000002788/ENSPREG00000016149/ENSPREG00000011546/ENSPREG00000007760/ENSPREG00000021597/ENSPREG00000004436/ENSPREG00000019962/ENSPREG00000017669/ENSPREG00000014038/ENSPREG00000003491/ENSPREG00000018746/ENSPREG00000016639/ENSPREG00000021316/ENSPREG00000000313/ENSPREG00000017180/ENSPREG00000011544/ENSPREG00000006716/ENSPREG00000010959/ENSPREG00000002135/ENSPREG00000002926
## GO:0030522 intracellular receptor signaling pathway                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                              ENSPREG00000000694/ENSPREG00000021486/ENSPREG00000009731/ENSPREG00000016519/ENSPREG00000008761/ENSPREG00000001824/ENSPREG00000018748/ENSPREG00000008698/ENSPREG00000013686/ENSPREG00000020437/ENSPREG00000001838/ENSPREG00000013209/ENSPREG00000009356/ENSPREG00000001562/ENSPREG00000004255/ENSPREG00000022630/ENSPREG00000011546
## GO:0004879 nuclear receptor activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                              ENSPREG00000000694/ENSPREG00000013420/ENSPREG00000021486/ENSPREG00000009731/ENSPREG00000016519/ENSPREG00000020502/ENSPREG00000008761/ENSPREG00000002510/ENSPREG00000001824/ENSPREG00000018748/ENSPREG00000008698/ENSPREG00000001598/ENSPREG00000013686/ENSPREG00000020437/ENSPREG00000001838/ENSPREG00000013209/ENSPREG00000009356/ENSPREG00000001562/ENSPREG00000004255/ENSPREG00000022630/ENSPREG00000011986/ENSPREG00000011546
## GO:0003677 DNA binding                                          ENSPREG00000001606/ENSPREG00000022182/ENSPREG00000006479/ENSPREG00000004660/ENSPREG00000012138/ENSPREG00000021365/ENSPREG00000009198/ENSPREG00000014369/ENSPREG00000005368/ENSPREG00000005374/ENSPREG00000014523/ENSPREG00000012367/ENSPREG00000004029/ENSPREG00000011115/ENSPREG00000012663/ENSPREG00000010341/ENSPREG00000019599/ENSPREG00000006777/ENSPREG00000008233/ENSPREG00000006061/ENSPREG00000019092/ENSPREG00000021725/ENSPREG00000020011/ENSPREG00000012965/ENSPREG00000006239/ENSPREG00000022564/ENSPREG00000000237/ENSPREG00000004107/ENSPREG00000006396/ENSPREG00000000142/ENSPREG00000005385/ENSPREG00000012188/ENSPREG00000000557/ENSPREG00000004218/ENSPREG00000016872/ENSPREG00000019859/ENSPREG00000020203/ENSPREG00000020178/ENSPREG00000016918/ENSPREG00000003633/ENSPREG00000007159/ENSPREG00000006450/ENSPREG00000021021/ENSPREG00000005993/ENSPREG00000009977/ENSPREG00000020070/ENSPREG00000019566/ENSPREG00000002923/ENSPREG00000019055/ENSPREG00000004689/ENSPREG00000015427/ENSPREG00000022772/ENSPREG00000016530/ENSPREG00000023177/ENSPREG00000013196/ENSPREG00000013812/ENSPREG00000017782/ENSPREG00000000694/ENSPREG00000020876/ENSPREG00000010340/ENSPREG00000000792/ENSPREG00000021337/ENSPREG00000005821/ENSPREG00000010656/ENSPREG00000010174/ENSPREG00000016605/ENSPREG00000012168/ENSPREG00000002999/ENSPREG00000012499/ENSPREG00000001380/ENSPREG00000000691/ENSPREG00000022948/ENSPREG00000019836/ENSPREG00000018786/ENSPREG00000021173/ENSPREG00000023186/ENSPREG00000018635/ENSPREG00000021824/ENSPREG00000021669/ENSPREG00000015542/ENSPREG00000004185/ENSPREG00000008193/ENSPREG00000009681/ENSPREG00000007643/ENSPREG00000017805/ENSPREG00000014207/ENSPREG00000021778/ENSPREG00000007944/ENSPREG00000022277/ENSPREG00000000563/ENSPREG00000014049/ENSPREG00000015529/ENSPREG00000002624/ENSPREG00000013420/ENSPREG00000012582/ENSPREG00000008773/ENSPREG00000008666/ENSPREG00000006219/ENSPREG00000000568/ENSPREG00000021397/ENSPREG00000019537/ENSPREG00000017347/ENSPREG00000002632/ENSPREG00000021486/ENSPREG00000009731/ENSPREG00000019321/ENSPREG00000016519/ENSPREG00000020502/ENSPREG00000018936/ENSPREG00000011223/ENSPREG00000016234/ENSPREG00000021553/ENSPREG00000017409/ENSPREG00000003428/ENSPREG00000013985/ENSPREG00000007985/ENSPREG00000003901/ENSPREG00000008761/ENSPREG00000006445/ENSPREG00000015252/ENSPREG00000019519/ENSPREG00000014770/ENSPREG00000020875/ENSPREG00000022614/ENSPREG00000020281/ENSPREG00000015870/ENSPREG00000004813/ENSPREG00000014025/ENSPREG00000018193/ENSPREG00000006787/ENSPREG00000017553/ENSPREG00000001758/ENSPREG00000004595/ENSPREG00000018117/ENSPREG00000023255/ENSPREG00000019601/ENSPREG00000015884/ENSPREG00000022145/ENSPREG00000018761/ENSPREG00000006276/ENSPREG00000002510/ENSPREG00000002117/ENSPREG00000016109/ENSPREG00000004444/ENSPREG00000023092/ENSPREG00000014446/ENSPREG00000008337/ENSPREG00000012260/ENSPREG00000012718/ENSPREG00000008684/ENSPREG00000004845/ENSPREG00000008636/ENSPREG00000007342/ENSPREG00000000683/ENSPREG00000002123/ENSPREG00000019101/ENSPREG00000004581/ENSPREG00000017112/ENSPREG00000001824/ENSPREG00000005256/ENSPREG00000014876/ENSPREG00000017164/ENSPREG00000018820/ENSPREG00000022956/ENSPREG00000004266/ENSPREG00000021717/ENSPREG00000019762/ENSPREG00000001592/ENSPREG00000018881/ENSPREG00000013623/ENSPREG00000011707/ENSPREG00000014745/ENSPREG00000008785/ENSPREG00000018748/ENSPREG00000020394/ENSPREG00000010865/ENSPREG00000020332/ENSPREG00000011064/ENSPREG00000017582/ENSPREG00000021719/ENSPREG00000022075/ENSPREG00000000414/ENSPREG00000013766/ENSPREG00000004023/ENSPREG00000016676/ENSPREG00000018249/ENSPREG00000013315/ENSPREG00000003001/ENSPREG00000011305/ENSPREG00000019479/ENSPREG00000008043/ENSPREG00000010061/ENSPREG00000014960/ENSPREG00000010783/ENSPREG00000008698/ENSPREG00000019423/ENSPREG00000014413/ENSPREG00000002904/ENSPREG00000009851/ENSPREG00000003088/ENSPREG00000022983/ENSPREG00000008377/ENSPREG00000013995/ENSPREG00000001598/ENSPREG00000007733/ENSPREG00000018024/ENSPREG00000014215/ENSPREG00000014513/ENSPREG00000013122/ENSPREG00000013775/ENSPREG00000022267/ENSPREG00000010797/ENSPREG00000004647/ENSPREG00000001340/ENSPREG00000009470/ENSPREG00000006621/ENSPREG00000012699/ENSPREG00000003063/ENSPREG00000008234/ENSPREG00000017475/ENSPREG00000011212/ENSPREG00000012254/ENSPREG00000004232/ENSPREG00000022924/ENSPREG00000013686/ENSPREG00000013067/ENSPREG00000022899/ENSPREG00000022906/ENSPREG00000022501/ENSPREG00000018873/ENSPREG00000009351/ENSPREG00000003939/ENSPREG00000008940/ENSPREG00000018224/ENSPREG00000005343/ENSPREG00000011400/ENSPREG00000017239/ENSPREG00000010913/ENSPREG00000012739/ENSPREG00000006760/ENSPREG00000000939/ENSPREG00000001346/ENSPREG00000002892/ENSPREG00000007818/ENSPREG00000005281/ENSPREG00000015073/ENSPREG00000004289/ENSPREG00000019546/ENSPREG00000012541/ENSPREG00000013386/ENSPREG00000020249/ENSPREG00000001360/ENSPREG00000015816/ENSPREG00000011913/ENSPREG00000016689/ENSPREG00000015465/ENSPREG00000008658/ENSPREG00000019200/ENSPREG00000013058/ENSPREG00000020458/ENSPREG00000019908/ENSPREG00000022812/ENSPREG00000013353/ENSPREG00000000532/ENSPREG00000021227/ENSPREG00000006758/ENSPREG00000006190/ENSPREG00000005805/ENSPREG00000014467/ENSPREG00000007900/ENSPREG00000009925/ENSPREG00000008418/ENSPREG00000017420/ENSPREG00000006077/ENSPREG00000016014/ENSPREG00000021274/ENSPREG00000012831/ENSPREG00000006606/ENSPREG00000015499/ENSPREG00000011231/ENSPREG00000013828/ENSPREG00000020437/ENSPREG00000015916/ENSPREG00000012063/ENSPREG00000012322/ENSPREG00000022066/ENSPREG00000008300/ENSPREG00000002591/ENSPREG00000018299/ENSPREG00000013601/ENSPREG00000008696/ENSPREG00000022283/ENSPREG00000009074/ENSPREG00000020206/ENSPREG00000014071/ENSPREG00000008141/ENSPREG00000009598/ENSPREG00000019019/ENSPREG00000008402/ENSPREG00000010196/ENSPREG00000013840/ENSPREG00000017901/ENSPREG00000006772/ENSPREG00000015450/ENSPREG00000001838/ENSPREG00000020918/ENSPREG00000008307/ENSPREG00000023222/ENSPREG00000019590/ENSPREG00000013209/ENSPREG00000008561/ENSPREG00000008918/ENSPREG00000023206/ENSPREG00000001397/ENSPREG00000013064/ENSPREG00000015468/ENSPREG00000009356/ENSPREG00000004970/ENSPREG00000002018/ENSPREG00000017077/ENSPREG00000008815/ENSPREG00000005380/ENSPREG00000006489/ENSPREG00000006819/ENSPREG00000011441/ENSPREG00000003558/ENSPREG00000018000/ENSPREG00000005612/ENSPREG00000001562/ENSPREG00000006631/ENSPREG00000008297/ENSPREG00000016663/ENSPREG00000002795/ENSPREG00000005286/ENSPREG00000016198/ENSPREG00000008992/ENSPREG00000017001/ENSPREG00000004255/ENSPREG00000018558/ENSPREG00000020287/ENSPREG00000020316/ENSPREG00000008197/ENSPREG00000008128/ENSPREG00000010379/ENSPREG00000021229/ENSPREG00000013048/ENSPREG00000020340/ENSPREG00000005578/ENSPREG00000011918/ENSPREG00000003379/ENSPREG00000006929/ENSPREG00000009834/ENSPREG00000011620/ENSPREG00000007407/ENSPREG00000022410/ENSPREG00000019385/ENSPREG00000012105/ENSPREG00000015326/ENSPREG00000014440/ENSPREG00000022630/ENSPREG00000004743/ENSPREG00000018387/ENSPREG00000007919/ENSPREG00000011986/ENSPREG00000011721/ENSPREG00000005288/ENSPREG00000011089/ENSPREG00000013684/ENSPREG00000014000/ENSPREG00000000278/ENSPREG00000017575/ENSPREG00000022971/ENSPREG00000018453/ENSPREG00000023212/ENSPREG00000020538/ENSPREG00000015004/ENSPREG00000022538/ENSPREG00000011292/ENSPREG00000000206/ENSPREG00000006003/ENSPREG00000017894/ENSPREG00000015189/ENSPREG00000015491/ENSPREG00000012015/ENSPREG00000010391/ENSPREG00000004628/ENSPREG00000017050/ENSPREG00000017276/ENSPREG00000013636/ENSPREG00000003992/ENSPREG00000006101/ENSPREG00000003325/ENSPREG00000014120/ENSPREG00000019278/ENSPREG00000017296/ENSPREG00000006187/ENSPREG00000008832/ENSPREG00000010102/ENSPREG00000001997/ENSPREG00000019531/ENSPREG00000022723/ENSPREG00000007996/ENSPREG00000002788/ENSPREG00000016149/ENSPREG00000011546/ENSPREG00000007760/ENSPREG00000021597/ENSPREG00000004436/ENSPREG00000003838/ENSPREG00000019962/ENSPREG00000004836/ENSPREG00000000466/ENSPREG00000004192/ENSPREG00000017669/ENSPREG00000014038/ENSPREG00000003491/ENSPREG00000018746/ENSPREG00000002849/ENSPREG00000016639/ENSPREG00000015289/ENSPREG00000001369/ENSPREG00000017180/ENSPREG00000011544/ENSPREG00000006716/ENSPREG00000010959/ENSPREG00000002135/ENSPREG00000002926/ENSPREG00000017120
## GO:0030837 negative regulation of actin filament polymerization                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000004859/ENSPREG00000012026/ENSPREG00000009872/ENSPREG00000002396/ENSPREG00000022136/ENSPREG00000006482/ENSPREG00000005608
## GO:0007409 axonogenesis                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000003714/ENSPREG00000009462/ENSPREG00000017257/ENSPREG00000019606/ENSPREG00000008887/ENSPREG00000013382/ENSPREG00000019248/ENSPREG00000007334/ENSPREG00000004376/ENSPREG00000000399/ENSPREG00000019454/ENSPREG00000019208/ENSPREG00000011222/ENSPREG00000009298/ENSPREG00000008300/ENSPREG00000008897/ENSPREG00000022658/ENSPREG00000021457/ENSPREG00000021949/ENSPREG00000005824/ENSPREG00000002212/ENSPREG00000010471
## GO:0032422 purine-rich negative regulatory element binding                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000004218/ENSPREG00000013084/ENSPREG00000019200/ENSPREG00000012322/ENSPREG00000015491
## GO:0003682 chromatin binding                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                   ENSPREG00000020416/ENSPREG00000016522/ENSPREG00000001380/ENSPREG00000007118/ENSPREG00000018256/ENSPREG00000007490/ENSPREG00000005028/ENSPREG00000015840/ENSPREG00000019882/ENSPREG00000002725/ENSPREG00000012260/ENSPREG00000019101/ENSPREG00000005463/ENSPREG00000004390/ENSPREG00000010086/ENSPREG00000002892/ENSPREG00000021274/ENSPREG00000008229/ENSPREG00000016999/ENSPREG00000008561/ENSPREG00000015213/ENSPREG00000011721/ENSPREG00000022723
## GO:0022625 cytosolic large ribosomal subunit                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                      ENSPREG00000022060/ENSPREG00000008655/ENSPREG00000008614/ENSPREG00000020132/ENSPREG00000022664/ENSPREG00000011980
## GO:0030155 regulation of cell adhesion                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                            ENSPREG00000020191/ENSPREG00000010044/ENSPREG00000011543/ENSPREG00000019336/ENSPREG00000006389/ENSPREG00000021917
##                                                                 Count
## GO:0046716 muscle cell cellular homeostasis                         7
## GO:0060294 cilium movement involved in cell motility                7
## GO:1905606 regulation of presynapse assembly                        7
## GO:0007275 multicellular organism development                     196
## GO:0009887 animal organ morphogenesis                              11
## GO:0006355 regulation of transcription, DNA-templated             339
## GO:0030522 intracellular receptor signaling pathway                17
## GO:0004879 nuclear receptor activity                               22
## GO:0003677 DNA binding                                            428
## GO:0030837 negative regulation of actin filament polymerization     7
## GO:0007409 axonogenesis                                            22
## GO:0032422 purine-rich negative regulatory element binding          5
## GO:0003682 chromatin binding                                       23
## GO:0022625 cytosolic large ribosomal subunit                        6
## GO:0030155 regulation of cell adhesion                              6
library(reshape2)


CvG_up <- subset(CvG,meth.diff>0&qvalue<0.001)
CvG_up <- unique(CvG_up$gene_id)
str(CvG_up)
##  chr [1:519] "ENSPREG00000021468" "ENSPREG00000021490" "ENSPREG00000000312" ...
CvG_dn <- subset(CvG,meth.diff<0&qvalue<0.001)
CvG_dn <- unique(CvG_dn$gene_id)
str(CvG_dn)
##  chr [1:973] "ENSPREG00000004582" "ENSPREG00000004594" "ENSPREG00000003390" ...
CvG_bg <- unique(CvG$gene_id)
str(CvG_bg)
##  chr [1:21591] "ENSPREG00000021468" "ENSPREG00000021490" ...
c_up <- enricher(gene = CvG_up, universe = CvG_bg, minGSSize = 5, maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_up,15)
##                                                                                                                                                                                                        ID
## GO:0006357 regulation of transcription by RNA polymerase II                                                                                   GO:0006357 regulation of transcription by RNA polymerase II
## GO:0043087 regulation of GTPase activity                                                                                                                         GO:0043087 regulation of GTPase activity
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                                         GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0008543 fibroblast growth factor receptor signaling pathway                                                                             GO:0008543 fibroblast growth factor receptor signaling pathway
## GO:0009253 peptidoglycan catabolic process                                                                                                                     GO:0009253 peptidoglycan catabolic process
## GO:0035256 G protein-coupled glutamate receptor binding                                                                                           GO:0035256 G protein-coupled glutamate receptor binding
## GO:0043154 negative regulation of cysteine-type endopeptidase activity involved in apoptotic process GO:0043154 negative regulation of cysteine-type endopeptidase activity involved in apoptotic process
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                                                               GO:0035479 angioblast cell migration from lateral mesoderm to midline
## GO:0046580 negative regulation of Ras protein signal transduction                                                                       GO:0046580 negative regulation of Ras protein signal transduction
## GO:0008270 zinc ion binding                                                                                                                                                   GO:0008270 zinc ion binding
## GO:0001525 angiogenesis                                                                                                                                                           GO:0001525 angiogenesis
## GO:0030155 regulation of cell adhesion                                                                                                                             GO:0030155 regulation of cell adhesion
## GO:0045176 apical protein localization                                                                                                                             GO:0045176 apical protein localization
## GO:0007275 multicellular organism development                                                                                                               GO:0007275 multicellular organism development
## GO:0003924 GTPase activity                                                                                                                                                     GO:0003924 GTPase activity
##                                                                                                                                                                                               Description
## GO:0006357 regulation of transcription by RNA polymerase II                                                                                   GO:0006357 regulation of transcription by RNA polymerase II
## GO:0043087 regulation of GTPase activity                                                                                                                         GO:0043087 regulation of GTPase activity
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                                         GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0008543 fibroblast growth factor receptor signaling pathway                                                                             GO:0008543 fibroblast growth factor receptor signaling pathway
## GO:0009253 peptidoglycan catabolic process                                                                                                                     GO:0009253 peptidoglycan catabolic process
## GO:0035256 G protein-coupled glutamate receptor binding                                                                                           GO:0035256 G protein-coupled glutamate receptor binding
## GO:0043154 negative regulation of cysteine-type endopeptidase activity involved in apoptotic process GO:0043154 negative regulation of cysteine-type endopeptidase activity involved in apoptotic process
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                                                               GO:0035479 angioblast cell migration from lateral mesoderm to midline
## GO:0046580 negative regulation of Ras protein signal transduction                                                                       GO:0046580 negative regulation of Ras protein signal transduction
## GO:0008270 zinc ion binding                                                                                                                                                   GO:0008270 zinc ion binding
## GO:0001525 angiogenesis                                                                                                                                                           GO:0001525 angiogenesis
## GO:0030155 regulation of cell adhesion                                                                                                                             GO:0030155 regulation of cell adhesion
## GO:0045176 apical protein localization                                                                                                                             GO:0045176 apical protein localization
## GO:0007275 multicellular organism development                                                                                                               GO:0007275 multicellular organism development
## GO:0003924 GTPase activity                                                                                                                                                     GO:0003924 GTPase activity
##                                                                                                      GeneRatio
## GO:0006357 regulation of transcription by RNA polymerase II                                             18/430
## GO:0043087 regulation of GTPase activity                                                                 4/430
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                        14/430
## GO:0008543 fibroblast growth factor receptor signaling pathway                                           4/430
## GO:0009253 peptidoglycan catabolic process                                                               2/430
## GO:0035256 G protein-coupled glutamate receptor binding                                                  2/430
## GO:0043154 negative regulation of cysteine-type endopeptidase activity involved in apoptotic process     2/430
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                                    2/430
## GO:0046580 negative regulation of Ras protein signal transduction                                        2/430
## GO:0008270 zinc ion binding                                                                             27/430
## GO:0001525 angiogenesis                                                                                  7/430
## GO:0030155 regulation of cell adhesion                                                                   2/430
## GO:0045176 apical protein localization                                                                   2/430
## GO:0007275 multicellular organism development                                                           20/430
## GO:0003924 GTPase activity                                                                              14/430
##                                                                                                        BgRatio
## GO:0006357 regulation of transcription by RNA polymerase II                                          370/18074
## GO:0043087 regulation of GTPase activity                                                              27/18074
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                     260/18074
## GO:0008543 fibroblast growth factor receptor signaling pathway                                        30/18074
## GO:0009253 peptidoglycan catabolic process                                                             5/18074
## GO:0035256 G protein-coupled glutamate receptor binding                                                5/18074
## GO:0043154 negative regulation of cysteine-type endopeptidase activity involved in apoptotic process   5/18074
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                                  6/18074
## GO:0046580 negative regulation of Ras protein signal transduction                                      6/18074
## GO:0008270 zinc ion binding                                                                          694/18074
## GO:0001525 angiogenesis                                                                               99/18074
## GO:0030155 regulation of cell adhesion                                                                 7/18074
## GO:0045176 apical protein localization                                                                 7/18074
## GO:0007275 multicellular organism development                                                        480/18074
## GO:0003924 GTPase activity                                                                           300/18074
##                                                                                                           pvalue
## GO:0006357 regulation of transcription by RNA polymerase II                                          0.003451916
## GO:0043087 regulation of GTPase activity                                                             0.003593029
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                     0.003913300
## GO:0008543 fibroblast growth factor receptor signaling pathway                                       0.005304989
## GO:0009253 peptidoglycan catabolic process                                                           0.005384525
## GO:0035256 G protein-coupled glutamate receptor binding                                              0.005384525
## GO:0043154 negative regulation of cysteine-type endopeptidase activity involved in apoptotic process 0.005384525
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                                0.007950019
## GO:0046580 negative regulation of Ras protein signal transduction                                    0.007950019
## GO:0008270 zinc ion binding                                                                          0.008704361
## GO:0001525 angiogenesis                                                                              0.009379973
## GO:0030155 regulation of cell adhesion                                                               0.010955685
## GO:0045176 apical protein localization                                                               0.010955685
## GO:0007275 multicellular organism development                                                        0.011329772
## GO:0003924 GTPase activity                                                                           0.013046373
##                                                                                                       p.adjust
## GO:0006357 regulation of transcription by RNA polymerase II                                          0.4846072
## GO:0043087 regulation of GTPase activity                                                             0.4846072
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                     0.4846072
## GO:0008543 fibroblast growth factor receptor signaling pathway                                       0.4846072
## GO:0009253 peptidoglycan catabolic process                                                           0.4846072
## GO:0035256 G protein-coupled glutamate receptor binding                                              0.4846072
## GO:0043154 negative regulation of cysteine-type endopeptidase activity involved in apoptotic process 0.4846072
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                                0.5046879
## GO:0046580 negative regulation of Ras protein signal transduction                                    0.5046879
## GO:0008270 zinc ion binding                                                                          0.5046879
## GO:0001525 angiogenesis                                                                              0.5046879
## GO:0030155 regulation of cell adhesion                                                               0.5046879
## GO:0045176 apical protein localization                                                               0.5046879
## GO:0007275 multicellular organism development                                                        0.5046879
## GO:0003924 GTPase activity                                                                           0.5046879
##                                                                                                         qvalue
## GO:0006357 regulation of transcription by RNA polymerase II                                          0.4704374
## GO:0043087 regulation of GTPase activity                                                             0.4704374
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                     0.4704374
## GO:0008543 fibroblast growth factor receptor signaling pathway                                       0.4704374
## GO:0009253 peptidoglycan catabolic process                                                           0.4704374
## GO:0035256 G protein-coupled glutamate receptor binding                                              0.4704374
## GO:0043154 negative regulation of cysteine-type endopeptidase activity involved in apoptotic process 0.4704374
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                                0.4899309
## GO:0046580 negative regulation of Ras protein signal transduction                                    0.4899309
## GO:0008270 zinc ion binding                                                                          0.4899309
## GO:0001525 angiogenesis                                                                              0.4899309
## GO:0030155 regulation of cell adhesion                                                               0.4899309
## GO:0045176 apical protein localization                                                               0.4899309
## GO:0007275 multicellular organism development                                                        0.4899309
## GO:0003924 GTPase activity                                                                           0.4899309
##                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                geneID
## GO:0006357 regulation of transcription by RNA polymerase II                                                                                                                                                                                                                     ENSPREG00000006479/ENSPREG00000004660/ENSPREG00000007804/ENSPREG00000009198/ENSPREG00000005368/ENSPREG00000005374/ENSPREG00000011115/ENSPREG00000006777/ENSPREG00000021725/ENSPREG00000020011/ENSPREG00000000237/ENSPREG00000016394/ENSPREG00000006396/ENSPREG00000020443/ENSPREG00000005385/ENSPREG00000012188/ENSPREG00000002057/ENSPREG00000000557
## GO:0043087 regulation of GTPase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                  ENSPREG00000017857/ENSPREG00000008324/ENSPREG00000004344/ENSPREG00000021572
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                                                                                                                                                                                                                                                                            ENSPREG00000006479/ENSPREG00000004660/ENSPREG00000009198/ENSPREG00000005368/ENSPREG00000005374/ENSPREG00000011115/ENSPREG00000006777/ENSPREG00000021725/ENSPREG00000020011/ENSPREG00000006396/ENSPREG00000005385/ENSPREG00000012188/ENSPREG00000002057/ENSPREG00000000557
## GO:0008543 fibroblast growth factor receptor signaling pathway                                                                                                                                                                                                                                                                                                                                                                                                                                                                                            ENSPREG00000021677/ENSPREG00000008601/ENSPREG00000009500/ENSPREG00000003394
## GO:0009253 peptidoglycan catabolic process                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                      ENSPREG00000017510/ENSPREG00000017953
## GO:0035256 G protein-coupled glutamate receptor binding                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                         ENSPREG00000003004/ENSPREG00000009990
## GO:0043154 negative regulation of cysteine-type endopeptidase activity involved in apoptotic process                                                                                                                                                                                                                                                                                                                                                                                                                                                                                            ENSPREG00000008541/ENSPREG00000004394
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000011756/ENSPREG00000010859
## GO:0046580 negative regulation of Ras protein signal transduction                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                               ENSPREG00000017857/ENSPREG00000004344
## GO:0008270 zinc ion binding                                                                          ENSPREG00000022182/ENSPREG00000005325/ENSPREG00000012138/ENSPREG00000017953/ENSPREG00000001755/ENSPREG00000018405/ENSPREG00000014023/ENSPREG00000017981/ENSPREG00000021715/ENSPREG00000017808/ENSPREG00000000488/ENSPREG00000012663/ENSPREG00000022214/ENSPREG00000010537/ENSPREG00000008233/ENSPREG00000009540/ENSPREG00000014502/ENSPREG00000000237/ENSPREG00000002840/ENSPREG00000008349/ENSPREG00000009995/ENSPREG00000012188/ENSPREG00000017244/ENSPREG00000022502/ENSPREG00000023192/ENSPREG00000017520/ENSPREG00000002000
## GO:0001525 angiogenesis                                                                                                                                                                                                                                                                                                                                                                                                                                                                          ENSPREG00000015617/ENSPREG00000000208/ENSPREG00000010035/ENSPREG00000001009/ENSPREG00000011756/ENSPREG00000001810/ENSPREG00000007027
## GO:0030155 regulation of cell adhesion                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                          ENSPREG00000020191/ENSPREG00000010044
## GO:0045176 apical protein localization                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                          ENSPREG00000018047/ENSPREG00000014551
## GO:0007275 multicellular organism development                                                                                                                                                                                             ENSPREG00000006479/ENSPREG00000004660/ENSPREG00000021420/ENSPREG00000009198/ENSPREG00000014369/ENSPREG00000005368/ENSPREG00000005374/ENSPREG00000011115/ENSPREG00000010035/ENSPREG00000007669/ENSPREG00000021106/ENSPREG00000011756/ENSPREG00000006777/ENSPREG00000021725/ENSPREG00000020011/ENSPREG00000006396/ENSPREG00000001810/ENSPREG00000005385/ENSPREG00000001804/ENSPREG00000000557
## GO:0003924 GTPase activity                                                                                                                                                                                                                                                                                                                                  ENSPREG00000014888/ENSPREG00000007438/ENSPREG00000014819/ENSPREG00000022241/ENSPREG00000005797/ENSPREG00000004803/ENSPREG00000017707/ENSPREG00000009158/ENSPREG00000019561/ENSPREG00000006955/ENSPREG00000003821/ENSPREG00000008323/ENSPREG00000008165/ENSPREG00000006630
##                                                                                                      Count
## GO:0006357 regulation of transcription by RNA polymerase II                                             18
## GO:0043087 regulation of GTPase activity                                                                 4
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                        14
## GO:0008543 fibroblast growth factor receptor signaling pathway                                           4
## GO:0009253 peptidoglycan catabolic process                                                               2
## GO:0035256 G protein-coupled glutamate receptor binding                                                  2
## GO:0043154 negative regulation of cysteine-type endopeptidase activity involved in apoptotic process     2
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                                    2
## GO:0046580 negative regulation of Ras protein signal transduction                                        2
## GO:0008270 zinc ion binding                                                                             27
## GO:0001525 angiogenesis                                                                                  7
## GO:0030155 regulation of cell adhesion                                                                   2
## GO:0045176 apical protein localization                                                                   2
## GO:0007275 multicellular organism development                                                           20
## GO:0003924 GTPase activity                                                                              14
c_dn <- enricher(gene = CvG_dn, universe = CvG_bg, minGSSize = 5,  maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_dn,15)
##                                                                                                              ID
## GO:0001780 neutrophil homeostasis                                             GO:0001780 neutrophil homeostasis
## GO:0031902 late endosome membrane                                             GO:0031902 late endosome membrane
## GO:0055008 cardiac muscle tissue morphogenesis                   GO:0055008 cardiac muscle tissue morphogenesis
## GO:0005765 lysosomal membrane                                                     GO:0005765 lysosomal membrane
## GO:0043087 regulation of GTPase activity                               GO:0043087 regulation of GTPase activity
## GO:0003677 DNA binding                                                                   GO:0003677 DNA binding
## GO:0008652 cellular amino acid biosynthetic process         GO:0008652 cellular amino acid biosynthetic process
## GO:0000123 histone acetyltransferase complex                       GO:0000123 histone acetyltransferase complex
## GO:0009617 response to bacterium                                               GO:0009617 response to bacterium
## GO:0003700 DNA-binding transcription factor activity       GO:0003700 DNA-binding transcription factor activity
## GO:0006325 chromatin organization                                             GO:0006325 chromatin organization
## GO:0002224 toll-like receptor signaling pathway                 GO:0002224 toll-like receptor signaling pathway
## GO:0000413 protein peptidyl-prolyl isomerization               GO:0000413 protein peptidyl-prolyl isomerization
## GO:0003755 peptidyl-prolyl cis-trans isomerase activity GO:0003755 peptidyl-prolyl cis-trans isomerase activity
## GO:0033180 proton-transporting V-type ATPase, V1 domain GO:0033180 proton-transporting V-type ATPase, V1 domain
##                                                                                                     Description
## GO:0001780 neutrophil homeostasis                                             GO:0001780 neutrophil homeostasis
## GO:0031902 late endosome membrane                                             GO:0031902 late endosome membrane
## GO:0055008 cardiac muscle tissue morphogenesis                   GO:0055008 cardiac muscle tissue morphogenesis
## GO:0005765 lysosomal membrane                                                     GO:0005765 lysosomal membrane
## GO:0043087 regulation of GTPase activity                               GO:0043087 regulation of GTPase activity
## GO:0003677 DNA binding                                                                   GO:0003677 DNA binding
## GO:0008652 cellular amino acid biosynthetic process         GO:0008652 cellular amino acid biosynthetic process
## GO:0000123 histone acetyltransferase complex                       GO:0000123 histone acetyltransferase complex
## GO:0009617 response to bacterium                                               GO:0009617 response to bacterium
## GO:0003700 DNA-binding transcription factor activity       GO:0003700 DNA-binding transcription factor activity
## GO:0006325 chromatin organization                                             GO:0006325 chromatin organization
## GO:0002224 toll-like receptor signaling pathway                 GO:0002224 toll-like receptor signaling pathway
## GO:0000413 protein peptidyl-prolyl isomerization               GO:0000413 protein peptidyl-prolyl isomerization
## GO:0003755 peptidyl-prolyl cis-trans isomerase activity GO:0003755 peptidyl-prolyl cis-trans isomerase activity
## GO:0033180 proton-transporting V-type ATPase, V1 domain GO:0033180 proton-transporting V-type ATPase, V1 domain
##                                                         GeneRatio    BgRatio
## GO:0001780 neutrophil homeostasis                           3/818    5/18074
## GO:0031902 late endosome membrane                           6/818   29/18074
## GO:0055008 cardiac muscle tissue morphogenesis              3/818    6/18074
## GO:0005765 lysosomal membrane                               8/818   57/18074
## GO:0043087 regulation of GTPase activity                    5/818   27/18074
## GO:0003677 DNA binding                                     69/818 1132/18074
## GO:0008652 cellular amino acid biosynthetic process         4/818   18/18074
## GO:0000123 histone acetyltransferase complex                3/818   10/18074
## GO:0009617 response to bacterium                            4/818   19/18074
## GO:0003700 DNA-binding transcription factor activity       32/818  464/18074
## GO:0006325 chromatin organization                           9/818   83/18074
## GO:0002224 toll-like receptor signaling pathway             4/818   21/18074
## GO:0000413 protein peptidyl-prolyl isomerization            6/818   44/18074
## GO:0003755 peptidyl-prolyl cis-trans isomerase activity     6/818   44/18074
## GO:0033180 proton-transporting V-type ATPase, V1 domain     3/818   12/18074
##                                                               pvalue  p.adjust
## GO:0001780 neutrophil homeostasis                       0.0008624249 0.4933654
## GO:0031902 late endosome membrane                       0.0016389411 0.4933654
## GO:0055008 cardiac muscle tissue morphogenesis          0.0016667751 0.4933654
## GO:0005765 lysosomal membrane                           0.0039375794 0.7340555
## GO:0043087 regulation of GTPase activity                0.0066026450 0.7340555
## GO:0003677 DNA binding                                  0.0070096498 0.7340555
## GO:0008652 cellular amino acid biosynthetic process     0.0076669378 0.7340555
## GO:0000123 histone acetyltransferase complex            0.0087274568 0.7340555
## GO:0009617 response to bacterium                        0.0093692959 0.7340555
## GO:0003700 DNA-binding transcription factor activity    0.0121349858 0.7340555
## GO:0006325 chromatin organization                       0.0125824691 0.7340555
## GO:0002224 toll-like receptor signaling pathway         0.0134683805 0.7340555
## GO:0000413 protein peptidyl-prolyl isomerization        0.0137289765 0.7340555
## GO:0003755 peptidyl-prolyl cis-trans isomerase activity 0.0137289765 0.7340555
## GO:0033180 proton-transporting V-type ATPase, V1 domain 0.0149546617 0.7340555
##                                                            qvalue
## GO:0001780 neutrophil homeostasis                       0.4859965
## GO:0031902 late endosome membrane                       0.4859965
## GO:0055008 cardiac muscle tissue morphogenesis          0.4859965
## GO:0005765 lysosomal membrane                           0.7230917
## GO:0043087 regulation of GTPase activity                0.7230917
## GO:0003677 DNA binding                                  0.7230917
## GO:0008652 cellular amino acid biosynthetic process     0.7230917
## GO:0000123 histone acetyltransferase complex            0.7230917
## GO:0009617 response to bacterium                        0.7230917
## GO:0003700 DNA-binding transcription factor activity    0.7230917
## GO:0006325 chromatin organization                       0.7230917
## GO:0002224 toll-like receptor signaling pathway         0.7230917
## GO:0000413 protein peptidyl-prolyl isomerization        0.7230917
## GO:0003755 peptidyl-prolyl cis-trans isomerase activity 0.7230917
## GO:0033180 proton-transporting V-type ATPase, V1 domain 0.7230917
##                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                 geneID
## GO:0001780 neutrophil homeostasis                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                             ENSPREG00000018748/ENSPREG00000008698/ENSPREG00000020541
## GO:0031902 late endosome membrane                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                    ENSPREG00000003165/ENSPREG00000021926/ENSPREG00000017357/ENSPREG00000011724/ENSPREG00000011436/ENSPREG00000020757
## GO:0055008 cardiac muscle tissue morphogenesis                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000005618/ENSPREG00000006261/ENSPREG00000001183
## GO:0005765 lysosomal membrane                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                  ENSPREG00000003165/ENSPREG00000001947/ENSPREG00000000381/ENSPREG00000016457/ENSPREG00000017357/ENSPREG00000005220/ENSPREG00000005255/ENSPREG00000022384
## GO:0043087 regulation of GTPase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000002871/ENSPREG00000014012/ENSPREG00000019661/ENSPREG00000023097/ENSPREG00000017204
## GO:0003677 DNA binding                                  ENSPREG00000018820/ENSPREG00000000557/ENSPREG00000022956/ENSPREG00000004266/ENSPREG00000021021/ENSPREG00000021717/ENSPREG00000019762/ENSPREG00000001592/ENSPREG00000018881/ENSPREG00000013623/ENSPREG00000011707/ENSPREG00000014745/ENSPREG00000008785/ENSPREG00000004107/ENSPREG00000018748/ENSPREG00000020394/ENSPREG00000010865/ENSPREG00000012718/ENSPREG00000020332/ENSPREG00000011064/ENSPREG00000017582/ENSPREG00000021719/ENSPREG00000022075/ENSPREG00000004581/ENSPREG00000000414/ENSPREG00000013766/ENSPREG00000004023/ENSPREG00000016676/ENSPREG00000018249/ENSPREG00000013315/ENSPREG00000003001/ENSPREG00000011305/ENSPREG00000012367/ENSPREG00000019479/ENSPREG00000021725/ENSPREG00000008043/ENSPREG00000010061/ENSPREG00000014960/ENSPREG00000016918/ENSPREG00000010783/ENSPREG00000008698/ENSPREG00000019423/ENSPREG00000014413/ENSPREG00000002904/ENSPREG00000009851/ENSPREG00000003088/ENSPREG00000022983/ENSPREG00000008377/ENSPREG00000013995/ENSPREG00000001598/ENSPREG00000007733/ENSPREG00000018024/ENSPREG00000014215/ENSPREG00000014513/ENSPREG00000013122/ENSPREG00000013775/ENSPREG00000000563/ENSPREG00000022267/ENSPREG00000010797/ENSPREG00000004647/ENSPREG00000001340/ENSPREG00000009470/ENSPREG00000006621/ENSPREG00000012699/ENSPREG00000003063/ENSPREG00000008234/ENSPREG00000013812/ENSPREG00000017475/ENSPREG00000011212
## GO:0008652 cellular amino acid biosynthetic process                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000009186/ENSPREG00000013056/ENSPREG00000000435/ENSPREG00000022693
## GO:0000123 histone acetyltransferase complex                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                  ENSPREG00000009968/ENSPREG00000015471/ENSPREG00000019647
## GO:0009617 response to bacterium                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000008790/ENSPREG00000015117/ENSPREG00000014489/ENSPREG00000020541
## GO:0003700 DNA-binding transcription factor activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                   ENSPREG00000000557/ENSPREG00000021021/ENSPREG00000019762/ENSPREG00000018881/ENSPREG00000014745/ENSPREG00000008785/ENSPREG00000018748/ENSPREG00000020332/ENSPREG00000011064/ENSPREG00000017582/ENSPREG00000021136/ENSPREG00000013766/ENSPREG00000016676/ENSPREG00000013315/ENSPREG00000012367/ENSPREG00000021725/ENSPREG00000016918/ENSPREG00000008698/ENSPREG00000022983/ENSPREG00000013995/ENSPREG00000001598/ENSPREG00000014513/ENSPREG00000013775/ENSPREG00000000563/ENSPREG00000022267/ENSPREG00000010797/ENSPREG00000004647/ENSPREG00000006621/ENSPREG00000012699/ENSPREG00000003063/ENSPREG00000010086/ENSPREG00000011212
## GO:0006325 chromatin organization                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000009968/ENSPREG00000010201/ENSPREG00000005463/ENSPREG00000020811/ENSPREG00000008274/ENSPREG00000004647/ENSPREG00000004390/ENSPREG00000011922/ENSPREG00000019898
## GO:0002224 toll-like receptor signaling pathway                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                            ENSPREG00000001890/ENSPREG00000019675/ENSPREG00000002257/ENSPREG00000001297
## GO:0000413 protein peptidyl-prolyl isomerization                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                     ENSPREG00000017903/ENSPREG00000018364/ENSPREG00000018430/ENSPREG00000019423/ENSPREG00000010703/ENSPREG00000001551
## GO:0003755 peptidyl-prolyl cis-trans isomerase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                              ENSPREG00000017903/ENSPREG00000018364/ENSPREG00000018430/ENSPREG00000019423/ENSPREG00000010703/ENSPREG00000001551
## GO:0033180 proton-transporting V-type ATPase, V1 domain                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                       ENSPREG00000022841/ENSPREG00000016458/ENSPREG00000019169
##                                                         Count
## GO:0001780 neutrophil homeostasis                           3
## GO:0031902 late endosome membrane                           6
## GO:0055008 cardiac muscle tissue morphogenesis              3
## GO:0005765 lysosomal membrane                               8
## GO:0043087 regulation of GTPase activity                    5
## GO:0003677 DNA binding                                     69
## GO:0008652 cellular amino acid biosynthetic process         4
## GO:0000123 histone acetyltransferase complex                3
## GO:0009617 response to bacterium                            4
## GO:0003700 DNA-binding transcription factor activity       32
## GO:0006325 chromatin organization                           9
## GO:0002224 toll-like receptor signaling pathway             4
## GO:0000413 protein peptidyl-prolyl isomerization            6
## GO:0003755 peptidyl-prolyl cis-trans isomerase activity     6
## GO:0033180 proton-transporting V-type ATPase, V1 domain     3
CvGunion <- union(CvG_up,CvG_dn)

c_union <- enricher(gene = CvGunion, universe = CvG_bg, minGSSize = 5,  maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_union,15)
##                                                                                                                                                                ID
## GO:0043087 regulation of GTPase activity                                                                                 GO:0043087 regulation of GTPase activity
## GO:0055008 cardiac muscle tissue morphogenesis                                                                     GO:0055008 cardiac muscle tissue morphogenesis
## GO:0001780 neutrophil homeostasis                                                                                               GO:0001780 neutrophil homeostasis
## GO:0003677 DNA binding                                                                                                                     GO:0003677 DNA binding
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                       GO:0035479 angioblast cell migration from lateral mesoderm to midline
## GO:0055129 L-proline biosynthetic process                                                                               GO:0055129 L-proline biosynthetic process
## GO:0015075 ion transmembrane transporter activity                                                               GO:0015075 ion transmembrane transporter activity
## GO:0030155 regulation of cell adhesion                                                                                     GO:0030155 regulation of cell adhesion
## GO:0004383 guanylate cyclase activity                                                                                       GO:0004383 guanylate cyclase activity
## GO:0006182 cGMP biosynthetic process                                                                                         GO:0006182 cGMP biosynthetic process
## GO:0071910 determination of liver left/right asymmetry                                                     GO:0071910 determination of liver left/right asymmetry
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0010468 regulation of gene expression                                                                                 GO:0010468 regulation of gene expression
## GO:0007275 multicellular organism development                                                                       GO:0007275 multicellular organism development
## GO:0031902 late endosome membrane                                                                                               GO:0031902 late endosome membrane
##                                                                                                                                                       Description
## GO:0043087 regulation of GTPase activity                                                                                 GO:0043087 regulation of GTPase activity
## GO:0055008 cardiac muscle tissue morphogenesis                                                                     GO:0055008 cardiac muscle tissue morphogenesis
## GO:0001780 neutrophil homeostasis                                                                                               GO:0001780 neutrophil homeostasis
## GO:0003677 DNA binding                                                                                                                     GO:0003677 DNA binding
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                       GO:0035479 angioblast cell migration from lateral mesoderm to midline
## GO:0055129 L-proline biosynthetic process                                                                               GO:0055129 L-proline biosynthetic process
## GO:0015075 ion transmembrane transporter activity                                                               GO:0015075 ion transmembrane transporter activity
## GO:0030155 regulation of cell adhesion                                                                                     GO:0030155 regulation of cell adhesion
## GO:0004383 guanylate cyclase activity                                                                                       GO:0004383 guanylate cyclase activity
## GO:0006182 cGMP biosynthetic process                                                                                         GO:0006182 cGMP biosynthetic process
## GO:0071910 determination of liver left/right asymmetry                                                     GO:0071910 determination of liver left/right asymmetry
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0010468 regulation of gene expression                                                                                 GO:0010468 regulation of gene expression
## GO:0007275 multicellular organism development                                                                       GO:0007275 multicellular organism development
## GO:0031902 late endosome membrane                                                                                               GO:0031902 late endosome membrane
##                                                                                  GeneRatio
## GO:0043087 regulation of GTPase activity                                            9/1226
## GO:0055008 cardiac muscle tissue morphogenesis                                      4/1226
## GO:0001780 neutrophil homeostasis                                                   3/1226
## GO:0003677 DNA binding                                                             99/1226
## GO:0035479 angioblast cell migration from lateral mesoderm to midline               3/1226
## GO:0055129 L-proline biosynthetic process                                           3/1226
## GO:0015075 ion transmembrane transporter activity                                   3/1226
## GO:0030155 regulation of cell adhesion                                              3/1226
## GO:0004383 guanylate cyclase activity                                               4/1226
## GO:0006182 cGMP biosynthetic process                                                4/1226
## GO:0071910 determination of liver left/right asymmetry                              4/1226
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific   28/1226
## GO:0010468 regulation of gene expression                                            7/1226
## GO:0007275 multicellular organism development                                      46/1226
## GO:0031902 late endosome membrane                                                   6/1226
##                                                                                     BgRatio
## GO:0043087 regulation of GTPase activity                                           27/18074
## GO:0055008 cardiac muscle tissue morphogenesis                                      6/18074
## GO:0001780 neutrophil homeostasis                                                   5/18074
## GO:0003677 DNA binding                                                           1132/18074
## GO:0035479 angioblast cell migration from lateral mesoderm to midline               6/18074
## GO:0055129 L-proline biosynthetic process                                           6/18074
## GO:0015075 ion transmembrane transporter activity                                   7/18074
## GO:0030155 regulation of cell adhesion                                              7/18074
## GO:0004383 guanylate cyclase activity                                              13/18074
## GO:0006182 cGMP biosynthetic process                                               13/18074
## GO:0071910 determination of liver left/right asymmetry                             13/18074
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific  260/18074
## GO:0010468 regulation of gene expression                                           37/18074
## GO:0007275 multicellular organism development                                     480/18074
## GO:0031902 late endosome membrane                                                  29/18074
##                                                                                        pvalue
## GO:0043087 regulation of GTPase activity                                         4.525557e-05
## GO:0055008 cardiac muscle tissue morphogenesis                                   2.828789e-04
## GO:0001780 neutrophil homeostasis                                                2.806421e-03
## GO:0003677 DNA binding                                                           5.102091e-03
## GO:0035479 angioblast cell migration from lateral mesoderm to midline            5.329963e-03
## GO:0055129 L-proline biosynthetic process                                        5.329963e-03
## GO:0015075 ion transmembrane transporter activity                                8.859052e-03
## GO:0030155 regulation of cell adhesion                                           8.859052e-03
## GO:0004383 guanylate cyclase activity                                            9.179574e-03
## GO:0006182 cGMP biosynthetic process                                             9.179574e-03
## GO:0071910 determination of liver left/right asymmetry                           9.179574e-03
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 1.039523e-02
## GO:0010468 regulation of gene expression                                         1.110295e-02
## GO:0007275 multicellular organism development                                    1.124933e-02
## GO:0031902 late endosome membrane                                                1.185465e-02
##                                                                                    p.adjust
## GO:0043087 regulation of GTPase activity                                         0.04946434
## GO:0055008 cardiac muscle tissue morphogenesis                                   0.15459334
## GO:0001780 neutrophil homeostasis                                                0.78896052
## GO:0003677 DNA binding                                                           0.78896052
## GO:0035479 angioblast cell migration from lateral mesoderm to midline            0.78896052
## GO:0055129 L-proline biosynthetic process                                        0.78896052
## GO:0015075 ion transmembrane transporter activity                                0.78896052
## GO:0030155 regulation of cell adhesion                                           0.78896052
## GO:0004383 guanylate cyclase activity                                            0.78896052
## GO:0006182 cGMP biosynthetic process                                             0.78896052
## GO:0071910 determination of liver left/right asymmetry                           0.78896052
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.78896052
## GO:0010468 regulation of gene expression                                         0.78896052
## GO:0007275 multicellular organism development                                    0.78896052
## GO:0031902 late endosome membrane                                                0.78896052
##                                                                                      qvalue
## GO:0043087 regulation of GTPase activity                                         0.04906657
## GO:0055008 cardiac muscle tissue morphogenesis                                   0.15335016
## GO:0001780 neutrophil homeostasis                                                0.78261602
## GO:0003677 DNA binding                                                           0.78261602
## GO:0035479 angioblast cell migration from lateral mesoderm to midline            0.78261602
## GO:0055129 L-proline biosynthetic process                                        0.78261602
## GO:0015075 ion transmembrane transporter activity                                0.78261602
## GO:0030155 regulation of cell adhesion                                           0.78261602
## GO:0004383 guanylate cyclase activity                                            0.78261602
## GO:0006182 cGMP biosynthetic process                                             0.78261602
## GO:0071910 determination of liver left/right asymmetry                           0.78261602
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.78261602
## GO:0010468 regulation of gene expression                                         0.78261602
## GO:0007275 multicellular organism development                                    0.78261602
## GO:0031902 late endosome membrane                                                0.78261602
##                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                    geneID
## GO:0043087 regulation of GTPase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                       ENSPREG00000017857/ENSPREG00000008324/ENSPREG00000004344/ENSPREG00000021572/ENSPREG00000002871/ENSPREG00000014012/ENSPREG00000019661/ENSPREG00000023097/ENSPREG00000017204
## GO:0055008 cardiac muscle tissue morphogenesis                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000007027/ENSPREG00000005618/ENSPREG00000006261/ENSPREG00000001183
## GO:0001780 neutrophil homeostasis                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000018748/ENSPREG00000008698/ENSPREG00000020541
## GO:0003677 DNA binding                                                           ENSPREG00000001606/ENSPREG00000022182/ENSPREG00000006479/ENSPREG00000004660/ENSPREG00000012138/ENSPREG00000021365/ENSPREG00000009198/ENSPREG00000014369/ENSPREG00000005368/ENSPREG00000005374/ENSPREG00000014523/ENSPREG00000012367/ENSPREG00000004029/ENSPREG00000011115/ENSPREG00000012663/ENSPREG00000010341/ENSPREG00000019599/ENSPREG00000006777/ENSPREG00000008233/ENSPREG00000006061/ENSPREG00000019092/ENSPREG00000021725/ENSPREG00000020011/ENSPREG00000012965/ENSPREG00000006239/ENSPREG00000022564/ENSPREG00000000237/ENSPREG00000004107/ENSPREG00000006396/ENSPREG00000000142/ENSPREG00000005385/ENSPREG00000012188/ENSPREG00000000557/ENSPREG00000004218/ENSPREG00000018820/ENSPREG00000022956/ENSPREG00000004266/ENSPREG00000021021/ENSPREG00000021717/ENSPREG00000019762/ENSPREG00000001592/ENSPREG00000018881/ENSPREG00000013623/ENSPREG00000011707/ENSPREG00000014745/ENSPREG00000008785/ENSPREG00000018748/ENSPREG00000020394/ENSPREG00000010865/ENSPREG00000012718/ENSPREG00000020332/ENSPREG00000011064/ENSPREG00000017582/ENSPREG00000021719/ENSPREG00000022075/ENSPREG00000004581/ENSPREG00000000414/ENSPREG00000013766/ENSPREG00000004023/ENSPREG00000016676/ENSPREG00000018249/ENSPREG00000013315/ENSPREG00000003001/ENSPREG00000011305/ENSPREG00000019479/ENSPREG00000008043/ENSPREG00000010061/ENSPREG00000014960/ENSPREG00000016918/ENSPREG00000010783/ENSPREG00000008698/ENSPREG00000019423/ENSPREG00000014413/ENSPREG00000002904/ENSPREG00000009851/ENSPREG00000003088/ENSPREG00000022983/ENSPREG00000008377/ENSPREG00000013995/ENSPREG00000001598/ENSPREG00000007733/ENSPREG00000018024/ENSPREG00000014215/ENSPREG00000014513/ENSPREG00000013122/ENSPREG00000013775/ENSPREG00000000563/ENSPREG00000022267/ENSPREG00000010797/ENSPREG00000004647/ENSPREG00000001340/ENSPREG00000009470/ENSPREG00000006621/ENSPREG00000012699/ENSPREG00000003063/ENSPREG00000008234/ENSPREG00000013812/ENSPREG00000017475/ENSPREG00000011212
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                            ENSPREG00000011756/ENSPREG00000010859/ENSPREG00000010464
## GO:0055129 L-proline biosynthetic process                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000006997/ENSPREG00000009186/ENSPREG00000000435
## GO:0015075 ion transmembrane transporter activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000003778/ENSPREG00000005776/ENSPREG00000007011
## GO:0030155 regulation of cell adhesion                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000020191/ENSPREG00000010044/ENSPREG00000021917
## GO:0004383 guanylate cyclase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                         ENSPREG00000017233/ENSPREG00000020922/ENSPREG00000002322/ENSPREG00000005428
## GO:0006182 cGMP biosynthetic process                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                          ENSPREG00000017233/ENSPREG00000020922/ENSPREG00000002322/ENSPREG00000005428
## GO:0071910 determination of liver left/right asymmetry                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000011756/ENSPREG00000010859/ENSPREG00000016753/ENSPREG00000010464
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                      ENSPREG00000006479/ENSPREG00000004660/ENSPREG00000009198/ENSPREG00000005368/ENSPREG00000005374/ENSPREG00000011115/ENSPREG00000006777/ENSPREG00000021725/ENSPREG00000020011/ENSPREG00000006396/ENSPREG00000005385/ENSPREG00000012188/ENSPREG00000002057/ENSPREG00000000557/ENSPREG00000021021/ENSPREG00000021717/ENSPREG00000013623/ENSPREG00000020332/ENSPREG00000021719/ENSPREG00000013766/ENSPREG00000003001/ENSPREG00000010783/ENSPREG00000022983/ENSPREG00000008377/ENSPREG00000000563/ENSPREG00000010797/ENSPREG00000001340/ENSPREG00000013812
## GO:0010468 regulation of gene expression                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                             ENSPREG00000018405/ENSPREG00000019660/ENSPREG00000011305/ENSPREG00000014413/ENSPREG00000014215/ENSPREG00000006621/ENSPREG00000013812
## GO:0007275 multicellular organism development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                   ENSPREG00000006479/ENSPREG00000004660/ENSPREG00000021420/ENSPREG00000009198/ENSPREG00000014369/ENSPREG00000005368/ENSPREG00000005374/ENSPREG00000011115/ENSPREG00000010035/ENSPREG00000007669/ENSPREG00000021106/ENSPREG00000011756/ENSPREG00000006777/ENSPREG00000021725/ENSPREG00000020011/ENSPREG00000006396/ENSPREG00000001810/ENSPREG00000005385/ENSPREG00000001804/ENSPREG00000000557/ENSPREG00000000612/ENSPREG00000021322/ENSPREG00000021021/ENSPREG00000021717/ENSPREG00000019762/ENSPREG00000020332/ENSPREG00000017582/ENSPREG00000021719/ENSPREG00000018360/ENSPREG00000013766/ENSPREG00000003001/ENSPREG00000009481/ENSPREG00000016378/ENSPREG00000010783/ENSPREG00000003088/ENSPREG00000022983/ENSPREG00000008377/ENSPREG00000004667/ENSPREG00000009349/ENSPREG00000014773/ENSPREG00000000563/ENSPREG00000010797/ENSPREG00000001340/ENSPREG00000013812/ENSPREG00000017475/ENSPREG00000005101
## GO:0031902 late endosome membrane                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                       ENSPREG00000003165/ENSPREG00000021926/ENSPREG00000017357/ENSPREG00000011724/ENSPREG00000011436/ENSPREG00000020757
##                                                                                  Count
## GO:0043087 regulation of GTPase activity                                             9
## GO:0055008 cardiac muscle tissue morphogenesis                                       4
## GO:0001780 neutrophil homeostasis                                                    3
## GO:0003677 DNA binding                                                              99
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                3
## GO:0055129 L-proline biosynthetic process                                            3
## GO:0015075 ion transmembrane transporter activity                                    3
## GO:0030155 regulation of cell adhesion                                               3
## GO:0004383 guanylate cyclase activity                                                4
## GO:0006182 cGMP biosynthetic process                                                 4
## GO:0071910 determination of liver left/right asymmetry                               4
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific    28
## GO:0010468 regulation of gene expression                                             7
## GO:0007275 multicellular organism development                                       46
## GO:0031902 late endosome membrane                                                    6
library(reshape2)


CvL_up <- subset(CvL,meth.diff>0&qvalue<0.05)
CvL_up <- unique(CvL_up$gene_id)
str(CvL_up)
##  chr [1:3018] "ENSPREG00000003617" "ENSPREG00000008406" ...
CvL_dn <- subset(CvL,meth.diff<0&qvalue<0.05)
CvL_dn <- unique(CvL_dn$gene_id)
str(CvL_dn)
##  chr [1:4039] "ENSPREG00000014846" "ENSPREG00000010182" ...
CvL_bg <- unique(CvL$gene_id)
str(CvL_bg)
##  chr [1:21581] "ENSPREG00000014846" "ENSPREG00000003617" ...
c_up <- enricher(gene = CvL_up, universe = CvL_bg, minGSSize = 5, maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_up,15)
##                                                                                                                                  ID
## GO:0005634 nucleus                                                                                               GO:0005634 nucleus
## GO:0060042 retina morphogenesis in camera-type eye                               GO:0060042 retina morphogenesis in camera-type eye
## GO:0007275 multicellular organism development                                         GO:0007275 multicellular organism development
## GO:0003700 DNA-binding transcription factor activity                           GO:0003700 DNA-binding transcription factor activity
## GO:0003677 DNA binding                                                                                       GO:0003677 DNA binding
## GO:0006355 regulation of transcription, DNA-templated                         GO:0006355 regulation of transcription, DNA-templated
## GO:0043401 steroid hormone mediated signaling pathway                         GO:0043401 steroid hormone mediated signaling pathway
## GO:0045666 positive regulation of neuron differentiation                   GO:0045666 positive regulation of neuron differentiation
## GO:0051382 kinetochore assembly                                                                     GO:0051382 kinetochore assembly
## GO:0072546 ER membrane protein complex                                                       GO:0072546 ER membrane protein complex
## GO:0005515 protein binding                                                                               GO:0005515 protein binding
## GO:0017154 semaphorin receptor activity                                                     GO:0017154 semaphorin receptor activity
## GO:0071526 semaphorin-plexin signaling pathway                                       GO:0071526 semaphorin-plexin signaling pathway
## GO:0060027 convergent extension involved in gastrulation                   GO:0060027 convergent extension involved in gastrulation
## GO:0004715 non-membrane spanning protein tyrosine kinase activity GO:0004715 non-membrane spanning protein tyrosine kinase activity
##                                                                                                                         Description
## GO:0005634 nucleus                                                                                               GO:0005634 nucleus
## GO:0060042 retina morphogenesis in camera-type eye                               GO:0060042 retina morphogenesis in camera-type eye
## GO:0007275 multicellular organism development                                         GO:0007275 multicellular organism development
## GO:0003700 DNA-binding transcription factor activity                           GO:0003700 DNA-binding transcription factor activity
## GO:0003677 DNA binding                                                                                       GO:0003677 DNA binding
## GO:0006355 regulation of transcription, DNA-templated                         GO:0006355 regulation of transcription, DNA-templated
## GO:0043401 steroid hormone mediated signaling pathway                         GO:0043401 steroid hormone mediated signaling pathway
## GO:0045666 positive regulation of neuron differentiation                   GO:0045666 positive regulation of neuron differentiation
## GO:0051382 kinetochore assembly                                                                     GO:0051382 kinetochore assembly
## GO:0072546 ER membrane protein complex                                                       GO:0072546 ER membrane protein complex
## GO:0005515 protein binding                                                                               GO:0005515 protein binding
## GO:0017154 semaphorin receptor activity                                                     GO:0017154 semaphorin receptor activity
## GO:0071526 semaphorin-plexin signaling pathway                                       GO:0071526 semaphorin-plexin signaling pathway
## GO:0060027 convergent extension involved in gastrulation                   GO:0060027 convergent extension involved in gastrulation
## GO:0004715 non-membrane spanning protein tyrosine kinase activity GO:0004715 non-membrane spanning protein tyrosine kinase activity
##                                                                   GeneRatio
## GO:0005634 nucleus                                                 363/2580
## GO:0060042 retina morphogenesis in camera-type eye                   9/2580
## GO:0007275 multicellular organism development                       94/2580
## GO:0003700 DNA-binding transcription factor activity                90/2580
## GO:0003677 DNA binding                                             196/2580
## GO:0006355 regulation of transcription, DNA-templated              155/2580
## GO:0043401 steroid hormone mediated signaling pathway                7/2580
## GO:0045666 positive regulation of neuron differentiation             5/2580
## GO:0051382 kinetochore assembly                                      4/2580
## GO:0072546 ER membrane protein complex                               4/2580
## GO:0005515 protein binding                                         531/2580
## GO:0017154 semaphorin receptor activity                              7/2580
## GO:0071526 semaphorin-plexin signaling pathway                       7/2580
## GO:0060027 convergent extension involved in gastrulation            12/2580
## GO:0004715 non-membrane spanning protein tyrosine kinase activity   11/2580
##                                                                      BgRatio
## GO:0005634 nucleus                                                2106/18067
## GO:0060042 retina morphogenesis in camera-type eye                  19/18067
## GO:0007275 multicellular organism development                      480/18067
## GO:0003700 DNA-binding transcription factor activity               463/18067
## GO:0003677 DNA binding                                            1131/18067
## GO:0006355 regulation of transcription, DNA-templated              875/18067
## GO:0043401 steroid hormone mediated signaling pathway               16/18067
## GO:0045666 positive regulation of neuron differentiation             9/18067
## GO:0051382 kinetochore assembly                                      6/18067
## GO:0072546 ER membrane protein complex                               6/18067
## GO:0005515 protein binding                                        3391/18067
## GO:0017154 semaphorin receptor activity                             17/18067
## GO:0071526 semaphorin-plexin signaling pathway                      17/18067
## GO:0060027 convergent extension involved in gastrulation            39/18067
## GO:0004715 non-membrane spanning protein tyrosine kinase activity   35/18067
##                                                                         pvalue
## GO:0005634 nucleus                                                3.093726e-05
## GO:0060042 retina morphogenesis in camera-type eye                5.778665e-04
## GO:0007275 multicellular organism development                     7.533353e-04
## GO:0003700 DNA-binding transcription factor activity              1.221920e-03
## GO:0003677 DNA binding                                            1.761198e-03
## GO:0006355 regulation of transcription, DNA-templated             2.156309e-03
## GO:0043401 steroid hormone mediated signaling pathway             4.200775e-03
## GO:0045666 positive regulation of neuron differentiation          4.510716e-03
## GO:0051382 kinetochore assembly                                   4.889189e-03
## GO:0072546 ER membrane protein complex                            4.889189e-03
## GO:0005515 protein binding                                        6.234231e-03
## GO:0017154 semaphorin receptor activity                           6.270641e-03
## GO:0071526 semaphorin-plexin signaling pathway                    6.270641e-03
## GO:0060027 convergent extension involved in gastrulation          6.491300e-03
## GO:0004715 non-membrane spanning protein tyrosine kinase activity 7.565802e-03
##                                                                     p.adjust
## GO:0005634 nucleus                                                0.04458059
## GO:0060042 retina morphogenesis in camera-type eye                0.36185205
## GO:0007275 multicellular organism development                     0.36185205
## GO:0003700 DNA-binding transcription factor activity              0.44019669
## GO:0003677 DNA binding                                            0.50757738
## GO:0006355 regulation of transcription, DNA-templated             0.51787358
## GO:0043401 steroid hormone mediated signaling pathway             0.62035989
## GO:0045666 positive regulation of neuron differentiation          0.62035989
## GO:0051382 kinetochore assembly                                   0.62035989
## GO:0072546 ER membrane protein complex                            0.62035989
## GO:0005515 protein binding                                        0.62035989
## GO:0017154 semaphorin receptor activity                           0.62035989
## GO:0071526 semaphorin-plexin signaling pathway                    0.62035989
## GO:0060027 convergent extension involved in gastrulation          0.62035989
## GO:0004715 non-membrane spanning protein tyrosine kinase activity 0.62035989
##                                                                       qvalue
## GO:0005634 nucleus                                                0.04458059
## GO:0060042 retina morphogenesis in camera-type eye                0.36185205
## GO:0007275 multicellular organism development                     0.36185205
## GO:0003700 DNA-binding transcription factor activity              0.44019669
## GO:0003677 DNA binding                                            0.50757738
## GO:0006355 regulation of transcription, DNA-templated             0.51787358
## GO:0043401 steroid hormone mediated signaling pathway             0.62035989
## GO:0045666 positive regulation of neuron differentiation          0.62035989
## GO:0051382 kinetochore assembly                                   0.62035989
## GO:0072546 ER membrane protein complex                            0.62035989
## GO:0005515 protein binding                                        0.62035989
## GO:0017154 semaphorin receptor activity                           0.62035989
## GO:0071526 semaphorin-plexin signaling pathway                    0.62035989
## GO:0060027 convergent extension involved in gastrulation          0.62035989
## GO:0004715 non-membrane spanning protein tyrosine kinase activity 0.62035989
##                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                     geneID
## GO:0005634 nucleus                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000011953/ENSPREG00000021725/ENSPREG00000011868/ENSPREG00000004660/ENSPREG00000014413/ENSPREG00000015451/ENSPREG00000002287/ENSPREG00000011568/ENSPREG00000022114/ENSPREG00000001380/ENSPREG00000012357/ENSPREG00000019101/ENSPREG00000004107/ENSPREG00000001606/ENSPREG00000009351/ENSPREG00000010174/ENSPREG00000022340/ENSPREG00000003434/ENSPREG00000019660/ENSPREG00000012325/ENSPREG00000000312/ENSPREG00000011115/ENSPREG00000012168/ENSPREG00000001505/ENSPREG00000007342/ENSPREG00000012367/ENSPREG00000019472/ENSPREG00000018852/ENSPREG00000011799/ENSPREG00000007722/ENSPREG00000002117/ENSPREG00000011856/ENSPREG00000005028/ENSPREG00000011367/ENSPREG00000012582/ENSPREG00000008389/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000005482/ENSPREG00000017808/ENSPREG00000010644/ENSPREG00000016347/ENSPREG00000017205/ENSPREG00000015529/ENSPREG00000012188/ENSPREG00000016534/ENSPREG00000013639/ENSPREG00000014531/ENSPREG00000016605/ENSPREG00000005993/ENSPREG00000014446/ENSPREG00000013940/ENSPREG00000009394/ENSPREG00000004581/ENSPREG00000018786/ENSPREG00000013384/ENSPREG00000013196/ENSPREG00000012003/ENSPREG00000009984/ENSPREG00000019274/ENSPREG00000017440/ENSPREG00000021982/ENSPREG00000003428/ENSPREG00000015828/ENSPREG00000000447/ENSPREG00000007638/ENSPREG00000003295/ENSPREG00000016437/ENSPREG00000017164/ENSPREG00000001484/ENSPREG00000018613/ENSPREG00000021691/ENSPREG00000003918/ENSPREG00000004218/ENSPREG00000020193/ENSPREG00000008997/ENSPREG00000013067/ENSPREG00000006372/ENSPREG00000009356/ENSPREG00000000386/ENSPREG00000012184/ENSPREG00000003897/ENSPREG00000010797/ENSPREG00000017870/ENSPREG00000009964/ENSPREG00000023148/ENSPREG00000003440/ENSPREG00000002923/ENSPREG00000013896/ENSPREG00000009540/ENSPREG00000022466/ENSPREG00000018024/ENSPREG00000022696/ENSPREG00000022365/ENSPREG00000014049/ENSPREG00000022088/ENSPREG00000016797/ENSPREG00000008456/ENSPREG00000020203/ENSPREG00000012868/ENSPREG00000005038/ENSPREG00000005223/ENSPREG00000007173/ENSPREG00000022277/ENSPREG00000020685/ENSPREG00000016742/ENSPREG00000005527/ENSPREG00000010381/ENSPREG00000014985/ENSPREG00000018023/ENSPREG00000013858/ENSPREG00000016063/ENSPREG00000018405/ENSPREG00000006464/ENSPREG00000018193/ENSPREG00000021362/ENSPREG00000018972/ENSPREG00000014803/ENSPREG00000000378/ENSPREG00000021553/ENSPREG00000003192/ENSPREG00000022267/ENSPREG00000021274/ENSPREG00000017405/ENSPREG00000007784/ENSPREG00000014523/ENSPREG00000005151/ENSPREG00000015738/ENSPREG00000018925/ENSPREG00000003423/ENSPREG00000010877/ENSPREG00000012529/ENSPREG00000018272/ENSPREG00000018746/ENSPREG00000009131/ENSPREG00000002487/ENSPREG00000007244/ENSPREG00000019470/ENSPREG00000012950/ENSPREG00000016198/ENSPREG00000011482/ENSPREG00000012663/ENSPREG00000012105/ENSPREG00000018630/ENSPREG00000008156/ENSPREG00000008418/ENSPREG00000008711/ENSPREG00000005278/ENSPREG00000005000/ENSPREG00000012965/ENSPREG00000017836/ENSPREG00000004058/ENSPREG00000000531/ENSPREG00000000532/ENSPREG00000001047/ENSPREG00000021700/ENSPREG00000011942/ENSPREG00000000639/ENSPREG00000007498/ENSPREG00000019795/ENSPREG00000015111/ENSPREG00000013601/ENSPREG00000014440/ENSPREG00000015315/ENSPREG00000018564/ENSPREG00000000136/ENSPREG00000001369/ENSPREG00000020625/ENSPREG00000000691/ENSPREG00000006796/ENSPREG00000003891/ENSPREG00000001598/ENSPREG00000016234/ENSPREG00000006038/ENSPREG00000015677/ENSPREG00000004185/ENSPREG00000010135/ENSPREG00000009925/ENSPREG00000015465/ENSPREG00000008666/ENSPREG00000008743/ENSPREG00000011827/ENSPREG00000020416/ENSPREG00000000793/ENSPREG00000015258/ENSPREG00000019319/ENSPREG00000014215/ENSPREG00000008960/ENSPREG00000010768/ENSPREG00000012719/ENSPREG00000020303/ENSPREG00000004213/ENSPREG00000001114/ENSPREG00000000568/ENSPREG00000007804/ENSPREG00000019031/ENSPREG00000013255/ENSPREG00000015981/ENSPREG00000009198/ENSPREG00000018196/ENSPREG00000015905/ENSPREG00000021952/ENSPREG00000008337/ENSPREG00000008276/ENSPREG00000015331/ENSPREG00000006032/ENSPREG00000006079/ENSPREG00000001395/ENSPREG00000014770/ENSPREG00000005288/ENSPREG00000003052/ENSPREG00000020093/ENSPREG00000020466/ENSPREG00000017365/ENSPREG00000002617/ENSPREG00000022194/ENSPREG00000010656/ENSPREG00000002331/ENSPREG00000010895/ENSPREG00000011231/ENSPREG00000000644/ENSPREG00000020796/ENSPREG00000021642/ENSPREG00000008761/ENSPREG00000000227/ENSPREG00000021410/ENSPREG00000017378/ENSPREG00000022485/ENSPREG00000002499/ENSPREG00000019694/ENSPREG00000022223/ENSPREG00000006606/ENSPREG00000005818/ENSPREG00000017291/ENSPREG00000009483/ENSPREG00000000662/ENSPREG00000021495/ENSPREG00000012055/ENSPREG00000006767/ENSPREG00000004782/ENSPREG00000017370/ENSPREG00000001155/ENSPREG00000021835/ENSPREG00000003285/ENSPREG00000005356/ENSPREG00000003764/ENSPREG00000018923/ENSPREG00000014826/ENSPREG00000020464/ENSPREG00000018565/ENSPREG00000006388/ENSPREG00000011196/ENSPREG00000015751/ENSPREG00000017854/ENSPREG00000015075/ENSPREG00000016109/ENSPREG00000019599/ENSPREG00000015503/ENSPREG00000004835/ENSPREG00000000100/ENSPREG00000001897/ENSPREG00000023206/ENSPREG00000003049/ENSPREG00000000694/ENSPREG00000006242/ENSPREG00000021707/ENSPREG00000007951/ENSPREG00000005599/ENSPREG00000020878/ENSPREG00000021865/ENSPREG00000006212/ENSPREG00000010684/ENSPREG00000022906/ENSPREG00000008235/ENSPREG00000022457/ENSPREG00000011388/ENSPREG00000006460/ENSPREG00000002677/ENSPREG00000001500/ENSPREG00000009177/ENSPREG00000004357/ENSPREG00000001222/ENSPREG00000020471/ENSPREG00000014973/ENSPREG00000013848/ENSPREG00000006544/ENSPREG00000017666/ENSPREG00000010486/ENSPREG00000010954/ENSPREG00000012420/ENSPREG00000006249/ENSPREG00000005374/ENSPREG00000006368/ENSPREG00000005136/ENSPREG00000019859/ENSPREG00000010250/ENSPREG00000018463/ENSPREG00000019898/ENSPREG00000018266/ENSPREG00000019315/ENSPREG00000013651/ENSPREG00000007743/ENSPREG00000007210/ENSPREG00000013766/ENSPREG00000019517/ENSPREG00000018366/ENSPREG00000016210/ENSPREG00000015597/ENSPREG00000005401/ENSPREG00000021784/ENSPREG00000005552/ENSPREG00000023092/ENSPREG00000011229/ENSPREG00000016918/ENSPREG00000020100/ENSPREG00000018675/ENSPREG00000002365/ENSPREG00000013087/ENSPREG00000004757/ENSPREG00000006777/ENSPREG00000019836/ENSPREG00000020877/ENSPREG00000004514/ENSPREG00000019394/ENSPREG00000009744/ENSPREG00000021857/ENSPREG00000015884/ENSPREG00000001387/ENSPREG00000004768/ENSPREG00000018793/ENSPREG00000011959/ENSPREG00000004628/ENSPREG00000010182/ENSPREG00000003677/ENSPREG00000015137/ENSPREG00000019858/ENSPREG00000021901/ENSPREG00000008937/ENSPREG00000011707/ENSPREG00000022075/ENSPREG00000016194/ENSPREG00000022711/ENSPREG00000000473/ENSPREG00000010143/ENSPREG00000018761/ENSPREG00000015470/ENSPREG00000020853/ENSPREG00000008500/ENSPREG00000002665/ENSPREG00000008032/ENSPREG00000022924/ENSPREG00000003148/ENSPREG00000017403/ENSPREG00000016149/ENSPREG00000008636/ENSPREG00000022772/ENSPREG00000007026/ENSPREG00000004345/ENSPREG00000001918/ENSPREG00000002123/ENSPREG00000017050/ENSPREG00000008906/ENSPREG00000013887
## GO:0060042 retina morphogenesis in camera-type eye                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                              ENSPREG00000011115/ENSPREG00000014551/ENSPREG00000000531/ENSPREG00000014440/ENSPREG00000013611/ENSPREG00000016351/ENSPREG00000002339/ENSPREG00000016542/ENSPREG00000002171
## GO:0007275 multicellular organism development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                    ENSPREG00000021725/ENSPREG00000004660/ENSPREG00000007669/ENSPREG00000022340/ENSPREG00000012325/ENSPREG00000011115/ENSPREG00000012168/ENSPREG00000007342/ENSPREG00000002117/ENSPREG00000011367/ENSPREG00000012582/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000005482/ENSPREG00000018360/ENSPREG00000016605/ENSPREG00000013196/ENSPREG00000017440/ENSPREG00000011227/ENSPREG00000009356/ENSPREG00000010797/ENSPREG00000019060/ENSPREG00000014049/ENSPREG00000016797/ENSPREG00000020203/ENSPREG00000022277/ENSPREG00000019287/ENSPREG00000018739/ENSPREG00000018023/ENSPREG00000015614/ENSPREG00000021144/ENSPREG00000018652/ENSPREG00000021274/ENSPREG00000003423/ENSPREG00000009131/ENSPREG00000012105/ENSPREG00000014369/ENSPREG00000020385/ENSPREG00000000531/ENSPREG00000000532/ENSPREG00000021420/ENSPREG00000007498/ENSPREG00000019795/ENSPREG00000013601/ENSPREG00000001369/ENSPREG00000004544/ENSPREG00000000691/ENSPREG00000006796/ENSPREG00000016234/ENSPREG00000021106/ENSPREG00000006008/ENSPREG00000000612/ENSPREG00000015465/ENSPREG00000021474/ENSPREG00000008357/ENSPREG00000000568/ENSPREG00000017388/ENSPREG00000009198/ENSPREG00000015936/ENSPREG00000015331/ENSPREG00000010656/ENSPREG00000008761/ENSPREG00000006606/ENSPREG00000010035/ENSPREG00000006767/ENSPREG00000016622/ENSPREG00000006388/ENSPREG00000023206/ENSPREG00000006544/ENSPREG00000020667/ENSPREG00000017666/ENSPREG00000008801/ENSPREG00000012420/ENSPREG00000005374/ENSPREG00000005136/ENSPREG00000010250/ENSPREG00000013766/ENSPREG00000009355/ENSPREG00000014891/ENSPREG00000007139/ENSPREG00000018675/ENSPREG00000006777/ENSPREG00000019836/ENSPREG00000015884/ENSPREG00000003313/ENSPREG00000004067/ENSPREG00000015470/ENSPREG00000002598/ENSPREG00000008500/ENSPREG00000019995/ENSPREG00000001918/ENSPREG00000002123/ENSPREG00000014903/ENSPREG00000021010
## GO:0003700 DNA-binding transcription factor activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                         ENSPREG00000021725/ENSPREG00000009351/ENSPREG00000010341/ENSPREG00000012168/ENSPREG00000012367/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000017205/ENSPREG00000015529/ENSPREG00000012188/ENSPREG00000014446/ENSPREG00000012003/ENSPREG00000021982/ENSPREG00000016437/ENSPREG00000013067/ENSPREG00000009356/ENSPREG00000010797/ENSPREG00000017870/ENSPREG00000009964/ENSPREG00000023148/ENSPREG00000009540/ENSPREG00000016797/ENSPREG00000020203/ENSPREG00000005038/ENSPREG00000014985/ENSPREG00000018193/ENSPREG00000014803/ENSPREG00000021553/ENSPREG00000022267/ENSPREG00000018746/ENSPREG00000002487/ENSPREG00000009502/ENSPREG00000012663/ENSPREG00000012965/ENSPREG00000014392/ENSPREG00000011942/ENSPREG00000013403/ENSPREG00000011496/ENSPREG00000013601/ENSPREG00000014440/ENSPREG00000020625/ENSPREG00000006796/ENSPREG00000001598/ENSPREG00000015677/ENSPREG00000004185/ENSPREG00000000512/ENSPREG00000015465/ENSPREG00000000568/ENSPREG00000015905/ENSPREG00000015331/ENSPREG00000001395/ENSPREG00000005288/ENSPREG00000020466/ENSPREG00000010895/ENSPREG00000011231/ENSPREG00000008761/ENSPREG00000005818/ENSPREG00000012055/ENSPREG00000006767/ENSPREG00000001199/ENSPREG00000014826/ENSPREG00000018565/ENSPREG00000016109/ENSPREG00000000694/ENSPREG00000022906/ENSPREG00000019842/ENSPREG00000001222/ENSPREG00000006368/ENSPREG00000005136/ENSPREG00000019859/ENSPREG00000013651/ENSPREG00000013766/ENSPREG00000016210/ENSPREG00000015597/ENSPREG00000023092/ENSPREG00000011229/ENSPREG00000016918/ENSPREG00000011725/ENSPREG00000013087/ENSPREG00000021303/ENSPREG00000004757/ENSPREG00000006777/ENSPREG00000004514/ENSPREG00000019394/ENSPREG00000004768/ENSPREG00000004628/ENSPREG00000010182/ENSPREG00000023255/ENSPREG00000016149/ENSPREG00000022772
## GO:0003677 DNA binding                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                         ENSPREG00000021725/ENSPREG00000004660/ENSPREG00000014413/ENSPREG00000004595/ENSPREG00000001380/ENSPREG00000019101/ENSPREG00000004107/ENSPREG00000001606/ENSPREG00000009351/ENSPREG00000010174/ENSPREG00000010341/ENSPREG00000022340/ENSPREG00000012325/ENSPREG00000011115/ENSPREG00000012168/ENSPREG00000007342/ENSPREG00000012367/ENSPREG00000002117/ENSPREG00000006450/ENSPREG00000011367/ENSPREG00000012582/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000015529/ENSPREG00000015289/ENSPREG00000012188/ENSPREG00000016605/ENSPREG00000005993/ENSPREG00000014446/ENSPREG00000013213/ENSPREG00000004581/ENSPREG00000018786/ENSPREG00000011157/ENSPREG00000013196/ENSPREG00000015341/ENSPREG00000012003/ENSPREG00000010940/ENSPREG00000017440/ENSPREG00000003428/ENSPREG00000016437/ENSPREG00000017164/ENSPREG00000021691/ENSPREG00000004218/ENSPREG00000007733/ENSPREG00000013067/ENSPREG00000015542/ENSPREG00000009356/ENSPREG00000012184/ENSPREG00000003897/ENSPREG00000008234/ENSPREG00000010797/ENSPREG00000012547/ENSPREG00000017870/ENSPREG00000009964/ENSPREG00000023148/ENSPREG00000002923/ENSPREG00000018024/ENSPREG00000007643/ENSPREG00000014049/ENSPREG00000022088/ENSPREG00000022317/ENSPREG00000016797/ENSPREG00000020203/ENSPREG00000005038/ENSPREG00000022277/ENSPREG00000014985/ENSPREG00000018023/ENSPREG00000018193/ENSPREG00000014803/ENSPREG00000021553/ENSPREG00000022267/ENSPREG00000021274/ENSPREG00000014523/ENSPREG00000015738/ENSPREG00000003423/ENSPREG00000019519/ENSPREG00000018746/ENSPREG00000009131/ENSPREG00000002487/ENSPREG00000012950/ENSPREG00000016198/ENSPREG00000012663/ENSPREG00000012105/ENSPREG00000008418/ENSPREG00000014369/ENSPREG00000012965/ENSPREG00000017553/ENSPREG00000000531/ENSPREG00000000532/ENSPREG00000008402/ENSPREG00000011942/ENSPREG00000021669/ENSPREG00000011496/ENSPREG00000007498/ENSPREG00000019795/ENSPREG00000013601/ENSPREG00000014440/ENSPREG00000001369/ENSPREG00000020625/ENSPREG00000000691/ENSPREG00000006796/ENSPREG00000001598/ENSPREG00000021365/ENSPREG00000016234/ENSPREG00000006061/ENSPREG00000003558/ENSPREG00000015677/ENSPREG00000004185/ENSPREG00000009925/ENSPREG00000015465/ENSPREG00000008666/ENSPREG00000015395/ENSPREG00000014215/ENSPREG00000001114/ENSPREG00000021474/ENSPREG00000000568/ENSPREG00000012765/ENSPREG00000009198/ENSPREG00000015905/ENSPREG00000008337/ENSPREG00000012389/ENSPREG00000015331/ENSPREG00000001395/ENSPREG00000014770/ENSPREG00000005288/ENSPREG00000020466/ENSPREG00000012499/ENSPREG00000017365/ENSPREG00000022194/ENSPREG00000010656/ENSPREG00000010895/ENSPREG00000011231/ENSPREG00000021586/ENSPREG00000000644/ENSPREG00000008761/ENSPREG00000006077/ENSPREG00000000227/ENSPREG00000021410/ENSPREG00000006606/ENSPREG00000012055/ENSPREG00000006767/ENSPREG00000001756/ENSPREG00000001199/ENSPREG00000017524/ENSPREG00000014826/ENSPREG00000017740/ENSPREG00000018565/ENSPREG00000006388/ENSPREG00000016109/ENSPREG00000019599/ENSPREG00000023206/ENSPREG00000000694/ENSPREG00000022906/ENSPREG00000022457/ENSPREG00000006460/ENSPREG00000022930/ENSPREG00000017666/ENSPREG00000010486/ENSPREG00000010954/ENSPREG00000012420/ENSPREG00000005374/ENSPREG00000006368/ENSPREG00000005136/ENSPREG00000019859/ENSPREG00000010250/ENSPREG00000013651/ENSPREG00000013766/ENSPREG00000015597/ENSPREG00000014774/ENSPREG00000023092/ENSPREG00000011229/ENSPREG00000016918/ENSPREG00000002365/ENSPREG00000006777/ENSPREG00000019836/ENSPREG00000020877/ENSPREG00000004514/ENSPREG00000015884/ENSPREG00000004768/ENSPREG00000004628/ENSPREG00000023255/ENSPREG00000010865/ENSPREG00000011707/ENSPREG00000022075/ENSPREG00000018761/ENSPREG00000015470/ENSPREG00000020876/ENSPREG00000020281/ENSPREG00000008500/ENSPREG00000022924/ENSPREG00000000237/ENSPREG00000016149/ENSPREG00000008636/ENSPREG00000022772/ENSPREG00000002123/ENSPREG00000017050
## GO:0006355 regulation of transcription, DNA-templated                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                     ENSPREG00000021725/ENSPREG00000004660/ENSPREG00000009351/ENSPREG00000010804/ENSPREG00000022340/ENSPREG00000012325/ENSPREG00000011115/ENSPREG00000012168/ENSPREG00000007342/ENSPREG00000012367/ENSPREG00000002117/ENSPREG00000005028/ENSPREG00000006450/ENSPREG00000011367/ENSPREG00000012582/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000017205/ENSPREG00000015529/ENSPREG00000012188/ENSPREG00000014446/ENSPREG00000013196/ENSPREG00000012003/ENSPREG00000018974/ENSPREG00000017440/ENSPREG00000021982/ENSPREG00000003428/ENSPREG00000016437/ENSPREG00000018613/ENSPREG00000003918/ENSPREG00000008997/ENSPREG00000013067/ENSPREG00000015542/ENSPREG00000009356/ENSPREG00000010797/ENSPREG00000017870/ENSPREG00000009964/ENSPREG00000023148/ENSPREG00000003440/ENSPREG00000009540/ENSPREG00000022365/ENSPREG00000014049/ENSPREG00000022317/ENSPREG00000016797/ENSPREG00000020203/ENSPREG00000005038/ENSPREG00000014985/ENSPREG00000018023/ENSPREG00000018193/ENSPREG00000021630/ENSPREG00000021362/ENSPREG00000014803/ENSPREG00000021553/ENSPREG00000022267/ENSPREG00000010581/ENSPREG00000007784/ENSPREG00000018925/ENSPREG00000003423/ENSPREG00000010877/ENSPREG00000019519/ENSPREG00000018746/ENSPREG00000009131/ENSPREG00000002487/ENSPREG00000012663/ENSPREG00000012105/ENSPREG00000012965/ENSPREG00000000531/ENSPREG00000000532/ENSPREG00000014392/ENSPREG00000008402/ENSPREG00000011942/ENSPREG00000013403/ENSPREG00000011496/ENSPREG00000007498/ENSPREG00000019795/ENSPREG00000013601/ENSPREG00000014440/ENSPREG00000020625/ENSPREG00000000691/ENSPREG00000006796/ENSPREG00000001598/ENSPREG00000021365/ENSPREG00000016234/ENSPREG00000015677/ENSPREG00000004185/ENSPREG00000000512/ENSPREG00000015465/ENSPREG00000015395/ENSPREG00000000568/ENSPREG00000015981/ENSPREG00000009198/ENSPREG00000018196/ENSPREG00000015905/ENSPREG00000008337/ENSPREG00000015331/ENSPREG00000001395/ENSPREG00000005288/ENSPREG00000020466/ENSPREG00000017365/ENSPREG00000010656/ENSPREG00000010895/ENSPREG00000011231/ENSPREG00000000644/ENSPREG00000008761/ENSPREG00000006606/ENSPREG00000005818/ENSPREG00000000662/ENSPREG00000012055/ENSPREG00000006767/ENSPREG00000021835/ENSPREG00000005356/ENSPREG00000001199/ENSPREG00000014826/ENSPREG00000018565/ENSPREG00000006388/ENSPREG00000016109/ENSPREG00000023206/ENSPREG00000000694/ENSPREG00000022906/ENSPREG00000022457/ENSPREG00000019842/ENSPREG00000001222/ENSPREG00000013848/ENSPREG00000006544/ENSPREG00000017666/ENSPREG00000012420/ENSPREG00000005374/ENSPREG00000006368/ENSPREG00000019859/ENSPREG00000010250/ENSPREG00000013651/ENSPREG00000013766/ENSPREG00000018366/ENSPREG00000016210/ENSPREG00000015597/ENSPREG00000023092/ENSPREG00000011229/ENSPREG00000016918/ENSPREG00000013087/ENSPREG00000006777/ENSPREG00000019836/ENSPREG00000004514/ENSPREG00000015884/ENSPREG00000004768/ENSPREG00000011959/ENSPREG00000004628/ENSPREG00000010182/ENSPREG00000023255/ENSPREG00000015470/ENSPREG00000020853/ENSPREG00000008500/ENSPREG00000016149/ENSPREG00000022772/ENSPREG00000018399/ENSPREG00000002123
## GO:0043401 steroid hormone mediated signaling pathway                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                 ENSPREG00000009351/ENSPREG00000008256/ENSPREG00000002487/ENSPREG00000011942/ENSPREG00000010895/ENSPREG00000000644/ENSPREG00000016149
## GO:0045666 positive regulation of neuron differentiation                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                    ENSPREG00000005560/ENSPREG00000020797/ENSPREG00000010498/ENSPREG00000015303/ENSPREG00000019394
## GO:0051382 kinetochore assembly                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000012547/ENSPREG00000003052/ENSPREG00000013147/ENSPREG00000004357
## GO:0072546 ER membrane protein complex                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                         ENSPREG00000006818/ENSPREG00000015075/ENSPREG00000017366/ENSPREG00000022652
## GO:0005515 protein binding                                        ENSPREG00000011953/ENSPREG00000003585/ENSPREG00000012853/ENSPREG00000004055/ENSPREG00000006443/ENSPREG00000020958/ENSPREG00000000164/ENSPREG00000002278/ENSPREG00000010544/ENSPREG00000001363/ENSPREG00000022961/ENSPREG00000002771/ENSPREG00000019101/ENSPREG00000016965/ENSPREG00000010341/ENSPREG00000000900/ENSPREG00000001335/ENSPREG00000000954/ENSPREG00000000312/ENSPREG00000007731/ENSPREG00000017981/ENSPREG00000019186/ENSPREG00000010064/ENSPREG00000017574/ENSPREG00000002476/ENSPREG00000021756/ENSPREG00000006662/ENSPREG00000017062/ENSPREG00000005051/ENSPREG00000022512/ENSPREG00000021269/ENSPREG00000017111/ENSPREG00000012251/ENSPREG00000006194/ENSPREG00000010675/ENSPREG00000003508/ENSPREG00000002457/ENSPREG00000018360/ENSPREG00000007359/ENSPREG00000010264/ENSPREG00000001755/ENSPREG00000022133/ENSPREG00000011250/ENSPREG00000009749/ENSPREG00000012218/ENSPREG00000008576/ENSPREG00000012822/ENSPREG00000022786/ENSPREG00000005421/ENSPREG00000015185/ENSPREG00000021217/ENSPREG00000016656/ENSPREG00000007748/ENSPREG00000004777/ENSPREG00000008770/ENSPREG00000022184/ENSPREG00000012394/ENSPREG00000009526/ENSPREG00000004054/ENSPREG00000020009/ENSPREG00000006259/ENSPREG00000004210/ENSPREG00000001857/ENSPREG00000016455/ENSPREG00000016460/ENSPREG00000010850/ENSPREG00000004636/ENSPREG00000006420/ENSPREG00000007238/ENSPREG00000005549/ENSPREG00000022326/ENSPREG00000022339/ENSPREG00000009984/ENSPREG00000006436/ENSPREG00000008019/ENSPREG00000004557/ENSPREG00000015324/ENSPREG00000018900/ENSPREG00000010906/ENSPREG00000003283/ENSPREG00000009016/ENSPREG00000023140/ENSPREG00000017454/ENSPREG00000021256/ENSPREG00000010905/ENSPREG00000005048/ENSPREG00000017448/ENSPREG00000009775/ENSPREG00000014023/ENSPREG00000003639/ENSPREG00000019504/ENSPREG00000020820/ENSPREG00000007778/ENSPREG00000008779/ENSPREG00000001445/ENSPREG00000009816/ENSPREG00000019197/ENSPREG00000001908/ENSPREG00000009568/ENSPREG00000011786/ENSPREG00000018613/ENSPREG00000021359/ENSPREG00000001707/ENSPREG00000014502/ENSPREG00000018480/ENSPREG00000003918/ENSPREG00000013331/ENSPREG00000015652/ENSPREG00000021494/ENSPREG00000018963/ENSPREG00000000685/ENSPREG00000011284/ENSPREG00000017061/ENSPREG00000006987/ENSPREG00000011331/ENSPREG00000003791/ENSPREG00000006498/ENSPREG00000013511/ENSPREG00000009287/ENSPREG00000020745/ENSPREG00000008863/ENSPREG00000014625/ENSPREG00000014332/ENSPREG00000008038/ENSPREG00000020473/ENSPREG00000022076/ENSPREG00000001939/ENSPREG00000022874/ENSPREG00000000609/ENSPREG00000012617/ENSPREG00000018667/ENSPREG00000004060/ENSPREG00000009991/ENSPREG00000012897/ENSPREG00000020768/ENSPREG00000000778/ENSPREG00000013339/ENSPREG00000016039/ENSPREG00000020999/ENSPREG00000013249/ENSPREG00000006035/ENSPREG00000022557/ENSPREG00000016525/ENSPREG00000022193/ENSPREG00000016649/ENSPREG00000016742/ENSPREG00000020310/ENSPREG00000019287/ENSPREG00000008034/ENSPREG00000020020/ENSPREG00000020573/ENSPREG00000018579/ENSPREG00000006914/ENSPREG00000018739/ENSPREG00000021915/ENSPREG00000009226/ENSPREG00000020590/ENSPREG00000003437/ENSPREG00000013858/ENSPREG00000001868/ENSPREG00000008052/ENSPREG00000017326/ENSPREG00000016063/ENSPREG00000009689/ENSPREG00000018193/ENSPREG00000017413/ENSPREG00000015614/ENSPREG00000008848/ENSPREG00000004374/ENSPREG00000009970/ENSPREG00000000119/ENSPREG00000021215/ENSPREG00000011322/ENSPREG00000006634/ENSPREG00000016838/ENSPREG00000004773/ENSPREG00000002585/ENSPREG00000012167/ENSPREG00000021481/ENSPREG00000014507/ENSPREG00000019656/ENSPREG00000018652/ENSPREG00000019132/ENSPREG00000010109/ENSPREG00000002194/ENSPREG00000018925/ENSPREG00000022191/ENSPREG00000010877/ENSPREG00000004259/ENSPREG00000017070/ENSPREG00000001142/ENSPREG00000004300/ENSPREG00000010225/ENSPREG00000010503/ENSPREG00000013653/ENSPREG00000005178/ENSPREG00000018468/ENSPREG00000014793/ENSPREG00000015578/ENSPREG00000017867/ENSPREG00000022029/ENSPREG00000018630/ENSPREG00000003604/ENSPREG00000002248/ENSPREG00000000125/ENSPREG00000020067/ENSPREG00000002348/ENSPREG00000017042/ENSPREG00000013496/ENSPREG00000012534/ENSPREG00000010160/ENSPREG00000021797/ENSPREG00000013675/ENSPREG00000015865/ENSPREG00000007974/ENSPREG00000019086/ENSPREG00000006294/ENSPREG00000014092/ENSPREG00000006797/ENSPREG00000007324/ENSPREG00000013327/ENSPREG00000010833/ENSPREG00000016362/ENSPREG00000004312/ENSPREG00000022420/ENSPREG00000012550/ENSPREG00000022289/ENSPREG00000016312/ENSPREG00000020729/ENSPREG00000002145/ENSPREG00000019855/ENSPREG00000001211/ENSPREG00000007903/ENSPREG00000004039/ENSPREG00000003645/ENSPREG00000016756/ENSPREG00000015315/ENSPREG00000020923/ENSPREG00000019248/ENSPREG00000022372/ENSPREG00000017615/ENSPREG00000013611/ENSPREG00000003891/ENSPREG00000015801/ENSPREG00000003542/ENSPREG00000021106/ENSPREG00000003558/ENSPREG00000010978/ENSPREG00000004149/ENSPREG00000017179/ENSPREG00000008818/ENSPREG00000014516/ENSPREG00000006673/ENSPREG00000010595/ENSPREG00000015791/ENSPREG00000006962/ENSPREG00000021539/ENSPREG00000010337/ENSPREG00000001779/ENSPREG00000007565/ENSPREG00000007331/ENSPREG00000014483/ENSPREG00000007218/ENSPREG00000021575/ENSPREG00000005611/ENSPREG00000000341/ENSPREG00000000779/ENSPREG00000017751/ENSPREG00000018891/ENSPREG00000017444/ENSPREG00000002366/ENSPREG00000015258/ENSPREG00000019319/ENSPREG00000011127/ENSPREG00000016459/ENSPREG00000012958/ENSPREG00000000598/ENSPREG00000007319/ENSPREG00000000130/ENSPREG00000018168/ENSPREG00000023130/ENSPREG00000003538/ENSPREG00000010253/ENSPREG00000009748/ENSPREG00000018357/ENSPREG00000020450/ENSPREG00000002792/ENSPREG00000003800/ENSPREG00000016483/ENSPREG00000006438/ENSPREG00000012231/ENSPREG00000016682/ENSPREG00000018477/ENSPREG00000000498/ENSPREG00000017820/ENSPREG00000012402/ENSPREG00000015306/ENSPREG00000003789/ENSPREG00000007632/ENSPREG00000002536/ENSPREG00000007006/ENSPREG00000015905/ENSPREG00000022828/ENSPREG00000001070/ENSPREG00000013271/ENSPREG00000006403/ENSPREG00000004343/ENSPREG00000020515/ENSPREG00000012225/ENSPREG00000013733/ENSPREG00000017328/ENSPREG00000014807/ENSPREG00000016967/ENSPREG00000013044/ENSPREG00000019090/ENSPREG00000004228/ENSPREG00000022838/ENSPREG00000019860/ENSPREG00000003161/ENSPREG00000018661/ENSPREG00000017365/ENSPREG00000019790/ENSPREG00000002917/ENSPREG00000019982/ENSPREG00000000629/ENSPREG00000006781/ENSPREG00000003290/ENSPREG00000020137/ENSPREG00000002735/ENSPREG00000018854/ENSPREG00000007262/ENSPREG00000004021/ENSPREG00000000588/ENSPREG00000000485/ENSPREG00000004632/ENSPREG00000019282/ENSPREG00000017951/ENSPREG00000020325/ENSPREG00000010697/ENSPREG00000009084/ENSPREG00000016523/ENSPREG00000008775/ENSPREG00000008786/ENSPREG00000007493/ENSPREG00000005420/ENSPREG00000022223/ENSPREG00000003169/ENSPREG00000009811/ENSPREG00000002766/ENSPREG00000022877/ENSPREG00000013687/ENSPREG00000018567/ENSPREG00000018440/ENSPREG00000008123/ENSPREG00000016650/ENSPREG00000016750/ENSPREG00000018609/ENSPREG00000020959/ENSPREG00000001407/ENSPREG00000019707/ENSPREG00000007789/ENSPREG00000009060/ENSPREG00000021856/ENSPREG00000020680/ENSPREG00000009420/ENSPREG00000018413/ENSPREG00000010270/ENSPREG00000014937/ENSPREG00000018664/ENSPREG00000010883/ENSPREG00000015764/ENSPREG00000018397/ENSPREG00000014672/ENSPREG00000007053/ENSPREG00000011196/ENSPREG00000015338/ENSPREG00000013074/ENSPREG00000020439/ENSPREG00000015075/ENSPREG00000019585/ENSPREG00000015346/ENSPREG00000016331/ENSPREG00000001436/ENSPREG00000011068/ENSPREG00000006820/ENSPREG00000001060/ENSPREG00000011431/ENSPREG00000011949/ENSPREG00000021865/ENSPREG00000012273/ENSPREG00000002972/ENSPREG00000014047/ENSPREG00000004576/ENSPREG00000006212/ENSPREG00000021455/ENSPREG00000022197/ENSPREG00000021205/ENSPREG00000022224/ENSPREG00000010089/ENSPREG00000001752/ENSPREG00000003965/ENSPREG00000002677/ENSPREG00000001500/ENSPREG00000009177/ENSPREG00000020822/ENSPREG00000008369/ENSPREG00000014973/ENSPREG00000018382/ENSPREG00000001103/ENSPREG00000002254/ENSPREG00000018823/ENSPREG00000006544/ENSPREG00000017366/ENSPREG00000010853/ENSPREG00000010858/ENSPREG00000022805/ENSPREG00000010817/ENSPREG00000011132/ENSPREG00000006025/ENSPREG00000005148/ENSPREG00000019039/ENSPREG00000005192/ENSPREG00000022668/ENSPREG00000013763/ENSPREG00000018266/ENSPREG00000017085/ENSPREG00000017018/ENSPREG00000015714/ENSPREG00000016542/ENSPREG00000001716/ENSPREG00000010039/ENSPREG00000012552/ENSPREG00000003515/ENSPREG00000014312/ENSPREG00000020669/ENSPREG00000018452/ENSPREG00000012989/ENSPREG00000018366/ENSPREG00000021218/ENSPREG00000015597/ENSPREG00000018361/ENSPREG00000014068/ENSPREG00000000638/ENSPREG00000000041/ENSPREG00000018926/ENSPREG00000006387/ENSPREG00000021765/ENSPREG00000011036/ENSPREG00000007582/ENSPREG00000002613/ENSPREG00000014065/ENSPREG00000009142/ENSPREG00000021158/ENSPREG00000007156/ENSPREG00000016621/ENSPREG00000018675/ENSPREG00000021550/ENSPREG00000022746/ENSPREG00000015956/ENSPREG00000004073/ENSPREG00000016118/ENSPREG00000018291/ENSPREG00000005026/ENSPREG00000006669/ENSPREG00000023229/ENSPREG00000023230/ENSPREG00000010400/ENSPREG00000021766/ENSPREG00000019394/ENSPREG00000005952/ENSPREG00000018173/ENSPREG00000011959/ENSPREG00000011957/ENSPREG00000010712/ENSPREG00000002171/ENSPREG00000003313/ENSPREG00000000688/ENSPREG00000001809/ENSPREG00000008648/ENSPREG00000004565/ENSPREG00000010345/ENSPREG00000005875/ENSPREG00000003677/ENSPREG00000018877/ENSPREG00000014041/ENSPREG00000018764/ENSPREG00000019858/ENSPREG00000017741/ENSPREG00000023155/ENSPREG00000001257/ENSPREG00000004963/ENSPREG00000021439/ENSPREG00000022257/ENSPREG00000023048/ENSPREG00000021901/ENSPREG00000003852/ENSPREG00000000473/ENSPREG00000009614/ENSPREG00000022808/ENSPREG00000011946/ENSPREG00000004067/ENSPREG00000018109/ENSPREG00000004566/ENSPREG00000011365/ENSPREG00000019135/ENSPREG00000015843/ENSPREG00000012147/ENSPREG00000021731/ENSPREG00000002598/ENSPREG00000022344/ENSPREG00000010201/ENSPREG00000000237/ENSPREG00000008086/ENSPREG00000009992/ENSPREG00000010914/ENSPREG00000022132/ENSPREG00000004587/ENSPREG00000011776/ENSPREG00000000802/ENSPREG00000000860/ENSPREG00000002240/ENSPREG00000021179/ENSPREG00000021917/ENSPREG00000001918/ENSPREG00000003732/ENSPREG00000001091/ENSPREG00000014903/ENSPREG00000018329/ENSPREG00000015691/ENSPREG00000021634/ENSPREG00000021653
## GO:0017154 semaphorin receptor activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                               ENSPREG00000013675/ENSPREG00000001211/ENSPREG00000006008/ENSPREG00000002766/ENSPREG00000010035/ENSPREG00000018664/ENSPREG00000015966
## GO:0071526 semaphorin-plexin signaling pathway                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000013675/ENSPREG00000001211/ENSPREG00000006008/ENSPREG00000002766/ENSPREG00000010035/ENSPREG00000018664/ENSPREG00000015966
## GO:0060027 convergent extension involved in gastrulation                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                               ENSPREG00000018568/ENSPREG00000015009/ENSPREG00000004039/ENSPREG00000006673/ENSPREG00000016583/ENSPREG00000020402/ENSPREG00000015764/ENSPREG00000004863/ENSPREG00000014312/ENSPREG00000020669/ENSPREG00000011843/ENSPREG00000000860
## GO:0004715 non-membrane spanning protein tyrosine kinase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                         ENSPREG00000001857/ENSPREG00000004058/ENSPREG00000019336/ENSPREG00000009040/ENSPREG00000013973/ENSPREG00000008419/ENSPREG00000006673/ENSPREG00000007632/ENSPREG00000011543/ENSPREG00000014312/ENSPREG00000018109
##                                                                   Count
## GO:0005634 nucleus                                                  363
## GO:0060042 retina morphogenesis in camera-type eye                    9
## GO:0007275 multicellular organism development                        94
## GO:0003700 DNA-binding transcription factor activity                 90
## GO:0003677 DNA binding                                              196
## GO:0006355 regulation of transcription, DNA-templated               155
## GO:0043401 steroid hormone mediated signaling pathway                 7
## GO:0045666 positive regulation of neuron differentiation              5
## GO:0051382 kinetochore assembly                                       4
## GO:0072546 ER membrane protein complex                                4
## GO:0005515 protein binding                                          531
## GO:0017154 semaphorin receptor activity                               7
## GO:0071526 semaphorin-plexin signaling pathway                        7
## GO:0060027 convergent extension involved in gastrulation             12
## GO:0004715 non-membrane spanning protein tyrosine kinase activity    11
c_dn <- enricher(gene = CvL_dn, universe = CvL_bg, minGSSize = 5,  maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_dn,15)
##                                                                                                                                    ID
## GO:0043565 sequence-specific DNA binding                                                     GO:0043565 sequence-specific DNA binding
## GO:0003677 DNA binding                                                                                         GO:0003677 DNA binding
## GO:0015075 ion transmembrane transporter activity                                   GO:0015075 ion transmembrane transporter activity
## GO:0004340 glucokinase activity                                                                       GO:0004340 glucokinase activity
## GO:0051156 glucose 6-phosphate metabolic process                                     GO:0051156 glucose 6-phosphate metabolic process
## GO:0060322 head development                                                                               GO:0060322 head development
## GO:0004000 adenosine deaminase activity                                                       GO:0004000 adenosine deaminase activity
## GO:0030513 positive regulation of BMP signaling pathway                       GO:0030513 positive regulation of BMP signaling pathway
## GO:0031017 exocrine pancreas development                                                     GO:0031017 exocrine pancreas development
## GO:0051056 regulation of small GTPase mediated signal transduction GO:0051056 regulation of small GTPase mediated signal transduction
## GO:0007062 sister chromatid cohesion                                                             GO:0007062 sister chromatid cohesion
## GO:0030111 regulation of Wnt signaling pathway                                         GO:0030111 regulation of Wnt signaling pathway
## GO:0060729 intestinal epithelial structure maintenance                         GO:0060729 intestinal epithelial structure maintenance
## GO:0001678 cellular glucose homeostasis                                                       GO:0001678 cellular glucose homeostasis
## GO:0004396 hexokinase activity                                                                         GO:0004396 hexokinase activity
##                                                                                                                           Description
## GO:0043565 sequence-specific DNA binding                                                     GO:0043565 sequence-specific DNA binding
## GO:0003677 DNA binding                                                                                         GO:0003677 DNA binding
## GO:0015075 ion transmembrane transporter activity                                   GO:0015075 ion transmembrane transporter activity
## GO:0004340 glucokinase activity                                                                       GO:0004340 glucokinase activity
## GO:0051156 glucose 6-phosphate metabolic process                                     GO:0051156 glucose 6-phosphate metabolic process
## GO:0060322 head development                                                                               GO:0060322 head development
## GO:0004000 adenosine deaminase activity                                                       GO:0004000 adenosine deaminase activity
## GO:0030513 positive regulation of BMP signaling pathway                       GO:0030513 positive regulation of BMP signaling pathway
## GO:0031017 exocrine pancreas development                                                     GO:0031017 exocrine pancreas development
## GO:0051056 regulation of small GTPase mediated signal transduction GO:0051056 regulation of small GTPase mediated signal transduction
## GO:0007062 sister chromatid cohesion                                                             GO:0007062 sister chromatid cohesion
## GO:0030111 regulation of Wnt signaling pathway                                         GO:0030111 regulation of Wnt signaling pathway
## GO:0060729 intestinal epithelial structure maintenance                         GO:0060729 intestinal epithelial structure maintenance
## GO:0001678 cellular glucose homeostasis                                                       GO:0001678 cellular glucose homeostasis
## GO:0004396 hexokinase activity                                                                         GO:0004396 hexokinase activity
##                                                                    GeneRatio
## GO:0043565 sequence-specific DNA binding                             60/3404
## GO:0003677 DNA binding                                              250/3404
## GO:0015075 ion transmembrane transporter activity                     5/3404
## GO:0004340 glucokinase activity                                       5/3404
## GO:0051156 glucose 6-phosphate metabolic process                      5/3404
## GO:0060322 head development                                           5/3404
## GO:0004000 adenosine deaminase activity                               6/3404
## GO:0030513 positive regulation of BMP signaling pathway               6/3404
## GO:0031017 exocrine pancreas development                             12/3404
## GO:0051056 regulation of small GTPase mediated signal transduction    8/3404
## GO:0007062 sister chromatid cohesion                                  4/3404
## GO:0030111 regulation of Wnt signaling pathway                        4/3404
## GO:0060729 intestinal epithelial structure maintenance                4/3404
## GO:0001678 cellular glucose homeostasis                               5/3404
## GO:0004396 hexokinase activity                                        5/3404
##                                                                       BgRatio
## GO:0043565 sequence-specific DNA binding                            221/18067
## GO:0003677 DNA binding                                             1131/18067
## GO:0015075 ion transmembrane transporter activity                     7/18067
## GO:0004340 glucokinase activity                                       8/18067
## GO:0051156 glucose 6-phosphate metabolic process                      8/18067
## GO:0060322 head development                                           8/18067
## GO:0004000 adenosine deaminase activity                              11/18067
## GO:0030513 positive regulation of BMP signaling pathway              11/18067
## GO:0031017 exocrine pancreas development                             32/18067
## GO:0051056 regulation of small GTPase mediated signal transduction   18/18067
## GO:0007062 sister chromatid cohesion                                  6/18067
## GO:0030111 regulation of Wnt signaling pathway                        6/18067
## GO:0060729 intestinal epithelial structure maintenance                6/18067
## GO:0001678 cellular glucose homeostasis                               9/18067
## GO:0004396 hexokinase activity                                        9/18067
##                                                                         pvalue
## GO:0043565 sequence-specific DNA binding                           0.001501922
## GO:0003677 DNA binding                                             0.002459385
## GO:0015075 ion transmembrane transporter activity                  0.003539694
## GO:0004340 glucokinase activity                                    0.007974799
## GO:0051156 glucose 6-phosphate metabolic process                   0.007974799
## GO:0060322 head development                                        0.007974799
## GO:0004000 adenosine deaminase activity                            0.008615010
## GO:0030513 positive regulation of BMP signaling pathway            0.008615010
## GO:0031017 exocrine pancreas development                           0.010430044
## GO:0051056 regulation of small GTPase mediated signal transduction 0.011353242
## GO:0007062 sister chromatid cohesion                               0.013636079
## GO:0030111 regulation of Wnt signaling pathway                     0.013636079
## GO:0060729 intestinal epithelial structure maintenance             0.013636079
## GO:0001678 cellular glucose homeostasis                            0.015175489
## GO:0004396 hexokinase activity                                     0.015175489
##                                                                     p.adjust
## GO:0043565 sequence-specific DNA binding                           0.9587427
## GO:0003677 DNA binding                                             0.9587427
## GO:0015075 ion transmembrane transporter activity                  0.9587427
## GO:0004340 glucokinase activity                                    0.9587427
## GO:0051156 glucose 6-phosphate metabolic process                   0.9587427
## GO:0060322 head development                                        0.9587427
## GO:0004000 adenosine deaminase activity                            0.9587427
## GO:0030513 positive regulation of BMP signaling pathway            0.9587427
## GO:0031017 exocrine pancreas development                           0.9587427
## GO:0051056 regulation of small GTPase mediated signal transduction 0.9587427
## GO:0007062 sister chromatid cohesion                               0.9587427
## GO:0030111 regulation of Wnt signaling pathway                     0.9587427
## GO:0060729 intestinal epithelial structure maintenance             0.9587427
## GO:0001678 cellular glucose homeostasis                            0.9587427
## GO:0004396 hexokinase activity                                     0.9587427
##                                                                       qvalue
## GO:0043565 sequence-specific DNA binding                           0.9587427
## GO:0003677 DNA binding                                             0.9587427
## GO:0015075 ion transmembrane transporter activity                  0.9587427
## GO:0004340 glucokinase activity                                    0.9587427
## GO:0051156 glucose 6-phosphate metabolic process                   0.9587427
## GO:0060322 head development                                        0.9587427
## GO:0004000 adenosine deaminase activity                            0.9587427
## GO:0030513 positive regulation of BMP signaling pathway            0.9587427
## GO:0031017 exocrine pancreas development                           0.9587427
## GO:0051056 regulation of small GTPase mediated signal transduction 0.9587427
## GO:0007062 sister chromatid cohesion                               0.9587427
## GO:0030111 regulation of Wnt signaling pathway                     0.9587427
## GO:0060729 intestinal epithelial structure maintenance             0.9587427
## GO:0001678 cellular glucose homeostasis                            0.9587427
## GO:0004396 hexokinase activity                                     0.9587427
##                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           geneID
## GO:0043565 sequence-specific DNA binding                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                     ENSPREG00000003481/ENSPREG00000015916/ENSPREG00000014745/ENSPREG00000013420/ENSPREG00000018748/ENSPREG00000015213/ENSPREG00000014440/ENSPREG00000013694/ENSPREG00000013209/ENSPREG00000013455/ENSPREG00000018565/ENSPREG00000005288/ENSPREG00000008785/ENSPREG00000015004/ENSPREG00000002018/ENSPREG00000013775/ENSPREG00000006479/ENSPREG00000013601/ENSPREG00000009351/ENSPREG00000009731/ENSPREG00000018100/ENSPREG00000017420/ENSPREG00000012360/ENSPREG00000008939/ENSPREG00000006060/ENSPREG00000004380/ENSPREG00000013995/ENSPREG00000018387/ENSPREG00000016519/ENSPREG00000001598/ENSPREG00000018881/ENSPREG00000017783/ENSPREG00000022899/ENSPREG00000022906/ENSPREG00000011721/ENSPREG00000013686/ENSPREG00000016437/ENSPREG00000011212/ENSPREG00000012367/ENSPREG00000017575/ENSPREG00000008858/ENSPREG00000015711/ENSPREG00000018486/ENSPREG00000018056/ENSPREG00000004772/ENSPREG00000009356/ENSPREG00000006969/ENSPREG00000013087/ENSPREG00000022246/ENSPREG00000006322/ENSPREG00000002822/ENSPREG00000011546/ENSPREG00000019601/ENSPREG00000008698/ENSPREG00000013840/ENSPREG00000013651/ENSPREG00000004768/ENSPREG00000011938/ENSPREG00000003572/ENSPREG00000019394
## GO:0003677 DNA binding                                             ENSPREG00000020332/ENSPREG00000000557/ENSPREG00000019590/ENSPREG00000020178/ENSPREG00000000563/ENSPREG00000021717/ENSPREG00000013122/ENSPREG00000021021/ENSPREG00000023222/ENSPREG00000015916/ENSPREG00000004581/ENSPREG00000013636/ENSPREG00000014960/ENSPREG00000013353/ENSPREG00000019423/ENSPREG00000021725/ENSPREG00000014513/ENSPREG00000011544/ENSPREG00000020875/ENSPREG00000008787/ENSPREG00000005380/ENSPREG00000011620/ENSPREG00000014745/ENSPREG00000013420/ENSPREG00000004436/ENSPREG00000011713/ENSPREG00000011707/ENSPREG00000013386/ENSPREG00000001606/ENSPREG00000018748/ENSPREG00000006489/ENSPREG00000016918/ENSPREG00000014279/ENSPREG00000020534/ENSPREG00000015854/ENSPREG00000021691/ENSPREG00000014440/ENSPREG00000018134/ENSPREG00000008300/ENSPREG00000008224/ENSPREG00000019762/ENSPREG00000013694/ENSPREG00000004375/ENSPREG00000004289/ENSPREG00000009681/ENSPREG00000013209/ENSPREG00000008658/ENSPREG00000000142/ENSPREG00000013058/ENSPREG00000012699/ENSPREG00000017112/ENSPREG00000018565/ENSPREG00000004079/ENSPREG00000002403/ENSPREG00000001340/ENSPREG00000005288/ENSPREG00000008785/ENSPREG00000010009/ENSPREG00000003558/ENSPREG00000020684/ENSPREG00000015004/ENSPREG00000020249/ENSPREG00000001364/ENSPREG00000006621/ENSPREG00000018868/ENSPREG00000017943/ENSPREG00000008636/ENSPREG00000020298/ENSPREG00000002018/ENSPREG00000020340/ENSPREG00000017440/ENSPREG00000008234/ENSPREG00000013775/ENSPREG00000010190/ENSPREG00000003001/ENSPREG00000001346/ENSPREG00000004743/ENSPREG00000006479/ENSPREG00000005343/ENSPREG00000003838/ENSPREG00000008307/ENSPREG00000013601/ENSPREG00000019385/ENSPREG00000018224/ENSPREG00000014517/ENSPREG00000006787/ENSPREG00000006190/ENSPREG00000009351/ENSPREG00000011305/ENSPREG00000017159/ENSPREG00000010210/ENSPREG00000007323/ENSPREG00000005805/ENSPREG00000009731/ENSPREG00000005657/ENSPREG00000010783/ENSPREG00000013048/ENSPREG00000018024/ENSPREG00000016694/ENSPREG00000004266/ENSPREG00000001397/ENSPREG00000014413/ENSPREG00000018820/ENSPREG00000017420/ENSPREG00000008763/ENSPREG00000008233/ENSPREG00000011115/ENSPREG00000005286/ENSPREG00000012547/ENSPREG00000007733/ENSPREG00000014285/ENSPREG00000008939/ENSPREG00000010863/ENSPREG00000019278/ENSPREG00000023206/ENSPREG00000002904/ENSPREG00000021719/ENSPREG00000002632/ENSPREG00000000644/ENSPREG00000017120/ENSPREG00000004380/ENSPREG00000012739/ENSPREG00000019570/ENSPREG00000006716/ENSPREG00000011496/ENSPREG00000004090/ENSPREG00000013995/ENSPREG00000008141/ENSPREG00000016198/ENSPREG00000018249/ENSPREG00000016109/ENSPREG00000018387/ENSPREG00000007818/ENSPREG00000019670/ENSPREG00000005517/ENSPREG00000013650/ENSPREG00000016519/ENSPREG00000023099/ENSPREG00000001598/ENSPREG00000000683/ENSPREG00000018973/ENSPREG00000011871/ENSPREG00000005851/ENSPREG00000022267/ENSPREG00000018881/ENSPREG00000017276/ENSPREG00000019908/ENSPREG00000008128/ENSPREG00000022182/ENSPREG00000022983/ENSPREG00000010865/ENSPREG00000017783/ENSPREG00000020349/ENSPREG00000012325/ENSPREG00000022899/ENSPREG00000022906/ENSPREG00000009470/ENSPREG00000018976/ENSPREG00000011721/ENSPREG00000004628/ENSPREG00000019546/ENSPREG00000015073/ENSPREG00000013686/ENSPREG00000021227/ENSPREG00000002385/ENSPREG00000013623/ENSPREG00000016437/ENSPREG00000008992/ENSPREG00000011212/ENSPREG00000020505/ENSPREG00000012254/ENSPREG00000012367/ENSPREG00000022812/ENSPREG00000017575/ENSPREG00000000939/ENSPREG00000019566/ENSPREG00000001559/ENSPREG00000008858/ENSPREG00000017296/ENSPREG00000009725/ENSPREG00000000532/ENSPREG00000015711/ENSPREG00000008109/ENSPREG00000005806/ENSPREG00000010240/ENSPREG00000018486/ENSPREG00000014876/ENSPREG00000004772/ENSPREG00000009356/ENSPREG00000008242/ENSPREG00000004775/ENSPREG00000011089/ENSPREG00000010913/ENSPREG00000014867/ENSPREG00000019480/ENSPREG00000007900/ENSPREG00000022246/ENSPREG00000014523/ENSPREG00000020306/ENSPREG00000021407/ENSPREG00000013155/ENSPREG00000017494/ENSPREG00000006276/ENSPREG00000020918/ENSPREG00000006322/ENSPREG00000013765/ENSPREG00000002822/ENSPREG00000006003/ENSPREG00000022075/ENSPREG00000021885/ENSPREG00000006772/ENSPREG00000003939/ENSPREG00000011546/ENSPREG00000012120/ENSPREG00000022283/ENSPREG00000015692/ENSPREG00000012582/ENSPREG00000012819/ENSPREG00000004425/ENSPREG00000019019/ENSPREG00000020577/ENSPREG00000017901/ENSPREG00000019601/ENSPREG00000011939/ENSPREG00000013115/ENSPREG00000015816/ENSPREG00000019608/ENSPREG00000008698/ENSPREG00000014298/ENSPREG00000013840/ENSPREG00000009616/ENSPREG00000009074/ENSPREG00000019092/ENSPREG00000001432/ENSPREG00000021255/ENSPREG00000015884/ENSPREG00000013313/ENSPREG00000019568/ENSPREG00000017553/ENSPREG00000009851/ENSPREG00000013651/ENSPREG00000006705/ENSPREG00000015810/ENSPREG00000012858/ENSPREG00000004768/ENSPREG00000004514/ENSPREG00000011938/ENSPREG00000016371/ENSPREG00000014784/ENSPREG00000003572
## GO:0015075 ion transmembrane transporter activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                 ENSPREG00000005776/ENSPREG00000007011/ENSPREG00000013279/ENSPREG00000003778/ENSPREG00000013471
## GO:0004340 glucokinase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                   ENSPREG00000014828/ENSPREG00000012652/ENSPREG00000010287/ENSPREG00000021465/ENSPREG00000009311
## GO:0051156 glucose 6-phosphate metabolic process                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                  ENSPREG00000014828/ENSPREG00000012652/ENSPREG00000010287/ENSPREG00000021465/ENSPREG00000009311
## GO:0060322 head development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                       ENSPREG00000008409/ENSPREG00000008456/ENSPREG00000016649/ENSPREG00000012139/ENSPREG00000013448
## GO:0004000 adenosine deaminase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000020270/ENSPREG00000016600/ENSPREG00000006572/ENSPREG00000006236/ENSPREG00000020675/ENSPREG00000003181
## GO:0030513 positive regulation of BMP signaling pathway                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000018051/ENSPREG00000019287/ENSPREG00000020925/ENSPREG00000022947/ENSPREG00000018278/ENSPREG00000006960
## GO:0031017 exocrine pancreas development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                     ENSPREG00000004106/ENSPREG00000011570/ENSPREG00000008300/ENSPREG00000001012/ENSPREG00000008858/ENSPREG00000000741/ENSPREG00000019499/ENSPREG00000005893/ENSPREG00000005265/ENSPREG00000002146/ENSPREG00000017553/ENSPREG00000002408
## GO:0051056 regulation of small GTPase mediated signal transduction                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                       ENSPREG00000006302/ENSPREG00000021844/ENSPREG00000010160/ENSPREG00000019661/ENSPREG00000005509/ENSPREG00000006207/ENSPREG00000008451/ENSPREG00000007850
## GO:0007062 sister chromatid cohesion                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                 ENSPREG00000012360/ENSPREG00000002380/ENSPREG00000016517/ENSPREG00000017552
## GO:0030111 regulation of Wnt signaling pathway                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                       ENSPREG00000006261/ENSPREG00000021155/ENSPREG00000019287/ENSPREG00000003447
## GO:0060729 intestinal epithelial structure maintenance                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                               ENSPREG00000008971/ENSPREG00000011304/ENSPREG00000008141/ENSPREG00000000741
## GO:0001678 cellular glucose homeostasis                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000014828/ENSPREG00000012652/ENSPREG00000010287/ENSPREG00000021465/ENSPREG00000009311
## GO:0004396 hexokinase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                    ENSPREG00000014828/ENSPREG00000012652/ENSPREG00000010287/ENSPREG00000021465/ENSPREG00000009311
##                                                                    Count
## GO:0043565 sequence-specific DNA binding                              60
## GO:0003677 DNA binding                                               250
## GO:0015075 ion transmembrane transporter activity                      5
## GO:0004340 glucokinase activity                                        5
## GO:0051156 glucose 6-phosphate metabolic process                       5
## GO:0060322 head development                                            5
## GO:0004000 adenosine deaminase activity                                6
## GO:0030513 positive regulation of BMP signaling pathway                6
## GO:0031017 exocrine pancreas development                              12
## GO:0051056 regulation of small GTPase mediated signal transduction     8
## GO:0007062 sister chromatid cohesion                                   4
## GO:0030111 regulation of Wnt signaling pathway                         4
## GO:0060729 intestinal epithelial structure maintenance                 4
## GO:0001678 cellular glucose homeostasis                                5
## GO:0004396 hexokinase activity                                         5
CvLunion <- union(CvL_up,CvL_dn)

c_union <- enricher(gene = CvLunion, universe = CvL_bg, minGSSize = 5,  maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_union,15)
##                                                                                                                                                                ID
## GO:0003677 DNA binding                                                                                                                     GO:0003677 DNA binding
## GO:0007275 multicellular organism development                                                                       GO:0007275 multicellular organism development
## GO:0005634 nucleus                                                                                                                             GO:0005634 nucleus
## GO:0043565 sequence-specific DNA binding                                                                                 GO:0043565 sequence-specific DNA binding
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0048471 perinuclear region of cytoplasm                                                                             GO:0048471 perinuclear region of cytoplasm
## GO:0015075 ion transmembrane transporter activity                                                               GO:0015075 ion transmembrane transporter activity
## GO:0030513 positive regulation of BMP signaling pathway                                                   GO:0030513 positive regulation of BMP signaling pathway
## GO:1902476 chloride transmembrane transport                                                                           GO:1902476 chloride transmembrane transport
## GO:0003700 DNA-binding transcription factor activity                                                         GO:0003700 DNA-binding transcription factor activity
## GO:0005515 protein binding                                                                                                             GO:0005515 protein binding
## GO:0009887 animal organ morphogenesis                                                                                       GO:0009887 animal organ morphogenesis
## GO:0006355 regulation of transcription, DNA-templated                                                       GO:0006355 regulation of transcription, DNA-templated
## GO:0006885 regulation of pH                                                                                                           GO:0006885 regulation of pH
## GO:0009190 cyclic nucleotide biosynthetic process                                                               GO:0009190 cyclic nucleotide biosynthetic process
##                                                                                                                                                       Description
## GO:0003677 DNA binding                                                                                                                     GO:0003677 DNA binding
## GO:0007275 multicellular organism development                                                                       GO:0007275 multicellular organism development
## GO:0005634 nucleus                                                                                                                             GO:0005634 nucleus
## GO:0043565 sequence-specific DNA binding                                                                                 GO:0043565 sequence-specific DNA binding
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0048471 perinuclear region of cytoplasm                                                                             GO:0048471 perinuclear region of cytoplasm
## GO:0015075 ion transmembrane transporter activity                                                               GO:0015075 ion transmembrane transporter activity
## GO:0030513 positive regulation of BMP signaling pathway                                                   GO:0030513 positive regulation of BMP signaling pathway
## GO:1902476 chloride transmembrane transport                                                                           GO:1902476 chloride transmembrane transport
## GO:0003700 DNA-binding transcription factor activity                                                         GO:0003700 DNA-binding transcription factor activity
## GO:0005515 protein binding                                                                                                             GO:0005515 protein binding
## GO:0009887 animal organ morphogenesis                                                                                       GO:0009887 animal organ morphogenesis
## GO:0006355 regulation of transcription, DNA-templated                                                       GO:0006355 regulation of transcription, DNA-templated
## GO:0006885 regulation of pH                                                                                                           GO:0006885 regulation of pH
## GO:0009190 cyclic nucleotide biosynthetic process                                                               GO:0009190 cyclic nucleotide biosynthetic process
##                                                                                  GeneRatio
## GO:0003677 DNA binding                                                            402/5544
## GO:0007275 multicellular organism development                                     184/5544
## GO:0005634 nucleus                                                                716/5544
## GO:0043565 sequence-specific DNA binding                                           91/5544
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific  103/5544
## GO:0048471 perinuclear region of cytoplasm                                         19/5544
## GO:0015075 ion transmembrane transporter activity                                   6/5544
## GO:0030513 positive regulation of BMP signaling pathway                             8/5544
## GO:1902476 chloride transmembrane transport                                         8/5544
## GO:0003700 DNA-binding transcription factor activity                              167/5544
## GO:0005515 protein binding                                                       1099/5544
## GO:0009887 animal organ morphogenesis                                               9/5544
## GO:0006355 regulation of transcription, DNA-templated                             300/5544
## GO:0006885 regulation of pH                                                         8/5544
## GO:0009190 cyclic nucleotide biosynthetic process                                  16/5544
##                                                                                     BgRatio
## GO:0003677 DNA binding                                                           1131/18067
## GO:0007275 multicellular organism development                                     480/18067
## GO:0005634 nucleus                                                               2106/18067
## GO:0043565 sequence-specific DNA binding                                          221/18067
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific  260/18067
## GO:0048471 perinuclear region of cytoplasm                                         35/18067
## GO:0015075 ion transmembrane transporter activity                                   7/18067
## GO:0030513 positive regulation of BMP signaling pathway                            11/18067
## GO:1902476 chloride transmembrane transport                                        11/18067
## GO:0003700 DNA-binding transcription factor activity                              463/18067
## GO:0005515 protein binding                                                       3391/18067
## GO:0009887 animal organ morphogenesis                                              14/18067
## GO:0006355 regulation of transcription, DNA-templated                             875/18067
## GO:0006885 regulation of pH                                                        12/18067
## GO:0009190 cyclic nucleotide biosynthetic process                                  31/18067
##                                                                                        pvalue
## GO:0003677 DNA binding                                                           0.0001689850
## GO:0007275 multicellular organism development                                    0.0001798022
## GO:0005634 nucleus                                                               0.0002743424
## GO:0043565 sequence-specific DNA binding                                         0.0005699700
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.0012765898
## GO:0048471 perinuclear region of cytoplasm                                       0.0030766027
## GO:0015075 ion transmembrane transporter activity                                0.0043000915
## GO:0030513 positive regulation of BMP signaling pathway                          0.0050035570
## GO:1902476 chloride transmembrane transport                                      0.0050035570
## GO:0003700 DNA-binding transcription factor activity                             0.0068640273
## GO:0005515 protein binding                                                       0.0085075763
## GO:0009887 animal organ morphogenesis                                            0.0097201957
## GO:0006355 regulation of transcription, DNA-templated                            0.0104028186
## GO:0006885 regulation of pH                                                      0.0109805817
## GO:0009190 cyclic nucleotide biosynthetic process                                0.0119545392
##                                                                                   p.adjust
## GO:0003677 DNA binding                                                           0.1551693
## GO:0007275 multicellular organism development                                    0.1551693
## GO:0005634 nucleus                                                               0.1578383
## GO:0043565 sequence-specific DNA binding                                         0.2459421
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.4406788
## GO:0048471 perinuclear region of cytoplasm                                       0.8850361
## GO:0015075 ion transmembrane transporter activity                                0.9142820
## GO:0030513 positive regulation of BMP signaling pathway                          0.9142820
## GO:1902476 chloride transmembrane transport                                      0.9142820
## GO:0003700 DNA-binding transcription factor activity                             0.9142820
## GO:0005515 protein binding                                                       0.9142820
## GO:0009887 animal organ morphogenesis                                            0.9142820
## GO:0006355 regulation of transcription, DNA-templated                            0.9142820
## GO:0006885 regulation of pH                                                      0.9142820
## GO:0009190 cyclic nucleotide biosynthetic process                                0.9142820
##                                                                                     qvalue
## GO:0003677 DNA binding                                                           0.1551693
## GO:0007275 multicellular organism development                                    0.1551693
## GO:0005634 nucleus                                                               0.1578383
## GO:0043565 sequence-specific DNA binding                                         0.2459421
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.4406788
## GO:0048471 perinuclear region of cytoplasm                                       0.8850361
## GO:0015075 ion transmembrane transporter activity                                0.9142820
## GO:0030513 positive regulation of BMP signaling pathway                          0.9142820
## GO:1902476 chloride transmembrane transport                                      0.9142820
## GO:0003700 DNA-binding transcription factor activity                             0.9142820
## GO:0005515 protein binding                                                       0.9142820
## GO:0009887 animal organ morphogenesis                                            0.9142820
## GO:0006355 regulation of transcription, DNA-templated                            0.9142820
## GO:0006885 regulation of pH                                                      0.9142820
## GO:0009190 cyclic nucleotide biosynthetic process                                0.9142820
##                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                            geneID
## GO:0003677 DNA binding                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                      ENSPREG00000021725/ENSPREG00000004660/ENSPREG00000014413/ENSPREG00000004595/ENSPREG00000001380/ENSPREG00000019101/ENSPREG00000004107/ENSPREG00000001606/ENSPREG00000009351/ENSPREG00000010174/ENSPREG00000010341/ENSPREG00000022340/ENSPREG00000012325/ENSPREG00000011115/ENSPREG00000012168/ENSPREG00000007342/ENSPREG00000012367/ENSPREG00000002117/ENSPREG00000006450/ENSPREG00000011367/ENSPREG00000012582/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000015529/ENSPREG00000015289/ENSPREG00000012188/ENSPREG00000016605/ENSPREG00000005993/ENSPREG00000014446/ENSPREG00000013213/ENSPREG00000004581/ENSPREG00000018786/ENSPREG00000011157/ENSPREG00000013196/ENSPREG00000015341/ENSPREG00000012003/ENSPREG00000010940/ENSPREG00000017440/ENSPREG00000003428/ENSPREG00000016437/ENSPREG00000017164/ENSPREG00000021691/ENSPREG00000004218/ENSPREG00000007733/ENSPREG00000013067/ENSPREG00000015542/ENSPREG00000009356/ENSPREG00000012184/ENSPREG00000003897/ENSPREG00000008234/ENSPREG00000010797/ENSPREG00000012547/ENSPREG00000017870/ENSPREG00000009964/ENSPREG00000023148/ENSPREG00000002923/ENSPREG00000018024/ENSPREG00000007643/ENSPREG00000014049/ENSPREG00000022088/ENSPREG00000022317/ENSPREG00000016797/ENSPREG00000020203/ENSPREG00000005038/ENSPREG00000022277/ENSPREG00000014985/ENSPREG00000018023/ENSPREG00000018193/ENSPREG00000014803/ENSPREG00000021553/ENSPREG00000022267/ENSPREG00000021274/ENSPREG00000014523/ENSPREG00000015738/ENSPREG00000003423/ENSPREG00000019519/ENSPREG00000018746/ENSPREG00000009131/ENSPREG00000002487/ENSPREG00000012950/ENSPREG00000016198/ENSPREG00000012663/ENSPREG00000012105/ENSPREG00000008418/ENSPREG00000014369/ENSPREG00000012965/ENSPREG00000017553/ENSPREG00000000531/ENSPREG00000000532/ENSPREG00000008402/ENSPREG00000011942/ENSPREG00000021669/ENSPREG00000011496/ENSPREG00000007498/ENSPREG00000019795/ENSPREG00000013601/ENSPREG00000014440/ENSPREG00000001369/ENSPREG00000020625/ENSPREG00000000691/ENSPREG00000006796/ENSPREG00000001598/ENSPREG00000021365/ENSPREG00000016234/ENSPREG00000006061/ENSPREG00000003558/ENSPREG00000015677/ENSPREG00000004185/ENSPREG00000009925/ENSPREG00000015465/ENSPREG00000008666/ENSPREG00000015395/ENSPREG00000014215/ENSPREG00000001114/ENSPREG00000021474/ENSPREG00000000568/ENSPREG00000012765/ENSPREG00000009198/ENSPREG00000015905/ENSPREG00000008337/ENSPREG00000012389/ENSPREG00000015331/ENSPREG00000001395/ENSPREG00000014770/ENSPREG00000005288/ENSPREG00000020466/ENSPREG00000012499/ENSPREG00000017365/ENSPREG00000022194/ENSPREG00000010656/ENSPREG00000010895/ENSPREG00000011231/ENSPREG00000021586/ENSPREG00000000644/ENSPREG00000008761/ENSPREG00000006077/ENSPREG00000000227/ENSPREG00000021410/ENSPREG00000006606/ENSPREG00000012055/ENSPREG00000006767/ENSPREG00000001756/ENSPREG00000001199/ENSPREG00000017524/ENSPREG00000014826/ENSPREG00000017740/ENSPREG00000018565/ENSPREG00000006388/ENSPREG00000016109/ENSPREG00000019599/ENSPREG00000023206/ENSPREG00000000694/ENSPREG00000022906/ENSPREG00000022457/ENSPREG00000006460/ENSPREG00000022930/ENSPREG00000017666/ENSPREG00000010486/ENSPREG00000010954/ENSPREG00000012420/ENSPREG00000005374/ENSPREG00000006368/ENSPREG00000005136/ENSPREG00000019859/ENSPREG00000010250/ENSPREG00000013651/ENSPREG00000013766/ENSPREG00000015597/ENSPREG00000014774/ENSPREG00000023092/ENSPREG00000011229/ENSPREG00000016918/ENSPREG00000002365/ENSPREG00000006777/ENSPREG00000019836/ENSPREG00000020877/ENSPREG00000004514/ENSPREG00000015884/ENSPREG00000004768/ENSPREG00000004628/ENSPREG00000023255/ENSPREG00000010865/ENSPREG00000011707/ENSPREG00000022075/ENSPREG00000018761/ENSPREG00000015470/ENSPREG00000020876/ENSPREG00000020281/ENSPREG00000008500/ENSPREG00000022924/ENSPREG00000000237/ENSPREG00000016149/ENSPREG00000008636/ENSPREG00000022772/ENSPREG00000002123/ENSPREG00000017050/ENSPREG00000020332/ENSPREG00000000557/ENSPREG00000019590/ENSPREG00000020178/ENSPREG00000000563/ENSPREG00000021717/ENSPREG00000013122/ENSPREG00000021021/ENSPREG00000023222/ENSPREG00000015916/ENSPREG00000013636/ENSPREG00000014960/ENSPREG00000013353/ENSPREG00000019423/ENSPREG00000014513/ENSPREG00000011544/ENSPREG00000020875/ENSPREG00000008787/ENSPREG00000005380/ENSPREG00000011620/ENSPREG00000014745/ENSPREG00000013420/ENSPREG00000004436/ENSPREG00000011713/ENSPREG00000013386/ENSPREG00000018748/ENSPREG00000006489/ENSPREG00000014279/ENSPREG00000020534/ENSPREG00000015854/ENSPREG00000018134/ENSPREG00000008300/ENSPREG00000008224/ENSPREG00000019762/ENSPREG00000013694/ENSPREG00000004375/ENSPREG00000004289/ENSPREG00000009681/ENSPREG00000013209/ENSPREG00000008658/ENSPREG00000000142/ENSPREG00000013058/ENSPREG00000012699/ENSPREG00000017112/ENSPREG00000004079/ENSPREG00000002403/ENSPREG00000001340/ENSPREG00000008785/ENSPREG00000010009/ENSPREG00000020684/ENSPREG00000015004/ENSPREG00000020249/ENSPREG00000001364/ENSPREG00000006621/ENSPREG00000018868/ENSPREG00000017943/ENSPREG00000020298/ENSPREG00000002018/ENSPREG00000013775/ENSPREG00000010190/ENSPREG00000003001/ENSPREG00000001346/ENSPREG00000004743/ENSPREG00000006479/ENSPREG00000005343/ENSPREG00000003838/ENSPREG00000008307/ENSPREG00000019385/ENSPREG00000018224/ENSPREG00000014517/ENSPREG00000006787/ENSPREG00000006190/ENSPREG00000011305/ENSPREG00000017159/ENSPREG00000010210/ENSPREG00000007323/ENSPREG00000005805/ENSPREG00000009731/ENSPREG00000005657/ENSPREG00000010783/ENSPREG00000013048/ENSPREG00000016694/ENSPREG00000004266/ENSPREG00000001397/ENSPREG00000018820/ENSPREG00000017420/ENSPREG00000008763/ENSPREG00000008233/ENSPREG00000005286/ENSPREG00000014285/ENSPREG00000008939/ENSPREG00000010863/ENSPREG00000019278/ENSPREG00000002904/ENSPREG00000021719/ENSPREG00000002632/ENSPREG00000017120/ENSPREG00000004380/ENSPREG00000012739/ENSPREG00000019570/ENSPREG00000006716/ENSPREG00000004090/ENSPREG00000013995/ENSPREG00000008141/ENSPREG00000018249/ENSPREG00000018387/ENSPREG00000007818/ENSPREG00000019670/ENSPREG00000005517/ENSPREG00000013650/ENSPREG00000016519/ENSPREG00000023099/ENSPREG00000000683/ENSPREG00000018973/ENSPREG00000011871/ENSPREG00000005851/ENSPREG00000018881/ENSPREG00000017276/ENSPREG00000019908/ENSPREG00000008128/ENSPREG00000022182/ENSPREG00000022983/ENSPREG00000017783/ENSPREG00000020349/ENSPREG00000022899/ENSPREG00000009470/ENSPREG00000018976/ENSPREG00000011721/ENSPREG00000019546/ENSPREG00000015073/ENSPREG00000013686/ENSPREG00000021227/ENSPREG00000002385/ENSPREG00000013623/ENSPREG00000008992/ENSPREG00000011212/ENSPREG00000020505/ENSPREG00000012254/ENSPREG00000022812/ENSPREG00000017575/ENSPREG00000000939/ENSPREG00000019566/ENSPREG00000001559/ENSPREG00000008858/ENSPREG00000017296/ENSPREG00000009725/ENSPREG00000015711/ENSPREG00000008109/ENSPREG00000005806/ENSPREG00000010240/ENSPREG00000018486/ENSPREG00000014876/ENSPREG00000004772/ENSPREG00000008242/ENSPREG00000004775/ENSPREG00000011089/ENSPREG00000010913/ENSPREG00000014867/ENSPREG00000019480/ENSPREG00000007900/ENSPREG00000022246/ENSPREG00000020306/ENSPREG00000021407/ENSPREG00000013155/ENSPREG00000017494/ENSPREG00000006276/ENSPREG00000020918/ENSPREG00000006322/ENSPREG00000013765/ENSPREG00000002822/ENSPREG00000006003/ENSPREG00000021885/ENSPREG00000006772/ENSPREG00000003939/ENSPREG00000011546/ENSPREG00000012120/ENSPREG00000022283/ENSPREG00000015692/ENSPREG00000012819/ENSPREG00000004425/ENSPREG00000019019/ENSPREG00000020577/ENSPREG00000017901/ENSPREG00000019601/ENSPREG00000011939/ENSPREG00000013115/ENSPREG00000015816/ENSPREG00000019608/ENSPREG00000008698/ENSPREG00000014298/ENSPREG00000013840/ENSPREG00000009616/ENSPREG00000009074/ENSPREG00000019092/ENSPREG00000001432/ENSPREG00000021255/ENSPREG00000013313/ENSPREG00000019568/ENSPREG00000009851/ENSPREG00000006705/ENSPREG00000015810/ENSPREG00000012858/ENSPREG00000011938/ENSPREG00000016371/ENSPREG00000014784/ENSPREG00000003572
## GO:0007275 multicellular organism development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                             ENSPREG00000021725/ENSPREG00000004660/ENSPREG00000007669/ENSPREG00000022340/ENSPREG00000012325/ENSPREG00000011115/ENSPREG00000012168/ENSPREG00000007342/ENSPREG00000002117/ENSPREG00000011367/ENSPREG00000012582/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000005482/ENSPREG00000018360/ENSPREG00000016605/ENSPREG00000013196/ENSPREG00000017440/ENSPREG00000011227/ENSPREG00000009356/ENSPREG00000010797/ENSPREG00000019060/ENSPREG00000014049/ENSPREG00000016797/ENSPREG00000020203/ENSPREG00000022277/ENSPREG00000019287/ENSPREG00000018739/ENSPREG00000018023/ENSPREG00000015614/ENSPREG00000021144/ENSPREG00000018652/ENSPREG00000021274/ENSPREG00000003423/ENSPREG00000009131/ENSPREG00000012105/ENSPREG00000014369/ENSPREG00000020385/ENSPREG00000000531/ENSPREG00000000532/ENSPREG00000021420/ENSPREG00000007498/ENSPREG00000019795/ENSPREG00000013601/ENSPREG00000001369/ENSPREG00000004544/ENSPREG00000000691/ENSPREG00000006796/ENSPREG00000016234/ENSPREG00000021106/ENSPREG00000006008/ENSPREG00000000612/ENSPREG00000015465/ENSPREG00000021474/ENSPREG00000008357/ENSPREG00000000568/ENSPREG00000017388/ENSPREG00000009198/ENSPREG00000015936/ENSPREG00000015331/ENSPREG00000010656/ENSPREG00000008761/ENSPREG00000006606/ENSPREG00000010035/ENSPREG00000006767/ENSPREG00000016622/ENSPREG00000006388/ENSPREG00000023206/ENSPREG00000006544/ENSPREG00000020667/ENSPREG00000017666/ENSPREG00000008801/ENSPREG00000012420/ENSPREG00000005374/ENSPREG00000005136/ENSPREG00000010250/ENSPREG00000013766/ENSPREG00000009355/ENSPREG00000014891/ENSPREG00000007139/ENSPREG00000018675/ENSPREG00000006777/ENSPREG00000019836/ENSPREG00000015884/ENSPREG00000003313/ENSPREG00000004067/ENSPREG00000015470/ENSPREG00000002598/ENSPREG00000008500/ENSPREG00000019995/ENSPREG00000001918/ENSPREG00000002123/ENSPREG00000014903/ENSPREG00000021010/ENSPREG00000020332/ENSPREG00000000557/ENSPREG00000020178/ENSPREG00000000563/ENSPREG00000021717/ENSPREG00000021021/ENSPREG00000000133/ENSPREG00000023233/ENSPREG00000014079/ENSPREG00000013636/ENSPREG00000010790/ENSPREG00000008016/ENSPREG00000013353/ENSPREG00000004106/ENSPREG00000004667/ENSPREG00000005380/ENSPREG00000011620/ENSPREG00000004436/ENSPREG00000011713/ENSPREG00000002679/ENSPREG00000008534/ENSPREG00000014279/ENSPREG00000009944/ENSPREG00000011176/ENSPREG00000008300/ENSPREG00000019762/ENSPREG00000009681/ENSPREG00000013209/ENSPREG00000009870/ENSPREG00000013058/ENSPREG00000001340/ENSPREG00000001364/ENSPREG00000018868/ENSPREG00000020298/ENSPREG00000003001/ENSPREG00000001346/ENSPREG00000011756/ENSPREG00000006479/ENSPREG00000005343/ENSPREG00000016378/ENSPREG00000006787/ENSPREG00000006190/ENSPREG00000009731/ENSPREG00000005657/ENSPREG00000010783/ENSPREG00000013048/ENSPREG00000016694/ENSPREG00000001397/ENSPREG00000021719/ENSPREG00000001227/ENSPREG00000019570/ENSPREG00000001810/ENSPREG00000006716/ENSPREG00000007694/ENSPREG00000011038/ENSPREG00000008325/ENSPREG00000019670/ENSPREG00000016519/ENSPREG00000000683/ENSPREG00000005851/ENSPREG00000022983/ENSPREG00000001835/ENSPREG00000020349/ENSPREG00000006129/ENSPREG00000011721/ENSPREG00000021227/ENSPREG00000020505/ENSPREG00000014719/ENSPREG00000008858/ENSPREG00000001265/ENSPREG00000011636/ENSPREG00000011089/ENSPREG00000007900/ENSPREG00000020306/ENSPREG00000021407/ENSPREG00000010793/ENSPREG00000006276/ENSPREG00000009481/ENSPREG00000002146/ENSPREG00000021885/ENSPREG00000012787/ENSPREG00000006772/ENSPREG00000015692/ENSPREG00000012819/ENSPREG00000017901/ENSPREG00000001804/ENSPREG00000000964/ENSPREG00000006705/ENSPREG00000015810/ENSPREG00000014784
## GO:0005634 nucleus                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                            ENSPREG00000011953/ENSPREG00000021725/ENSPREG00000011868/ENSPREG00000004660/ENSPREG00000014413/ENSPREG00000015451/ENSPREG00000002287/ENSPREG00000011568/ENSPREG00000022114/ENSPREG00000001380/ENSPREG00000012357/ENSPREG00000019101/ENSPREG00000004107/ENSPREG00000001606/ENSPREG00000009351/ENSPREG00000010174/ENSPREG00000022340/ENSPREG00000003434/ENSPREG00000019660/ENSPREG00000012325/ENSPREG00000000312/ENSPREG00000011115/ENSPREG00000012168/ENSPREG00000001505/ENSPREG00000007342/ENSPREG00000012367/ENSPREG00000019472/ENSPREG00000018852/ENSPREG00000011799/ENSPREG00000007722/ENSPREG00000002117/ENSPREG00000011856/ENSPREG00000005028/ENSPREG00000011367/ENSPREG00000012582/ENSPREG00000008389/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000005482/ENSPREG00000017808/ENSPREG00000010644/ENSPREG00000016347/ENSPREG00000017205/ENSPREG00000015529/ENSPREG00000012188/ENSPREG00000016534/ENSPREG00000013639/ENSPREG00000014531/ENSPREG00000016605/ENSPREG00000005993/ENSPREG00000014446/ENSPREG00000013940/ENSPREG00000009394/ENSPREG00000004581/ENSPREG00000018786/ENSPREG00000013384/ENSPREG00000013196/ENSPREG00000012003/ENSPREG00000009984/ENSPREG00000019274/ENSPREG00000017440/ENSPREG00000021982/ENSPREG00000003428/ENSPREG00000015828/ENSPREG00000000447/ENSPREG00000007638/ENSPREG00000003295/ENSPREG00000016437/ENSPREG00000017164/ENSPREG00000001484/ENSPREG00000018613/ENSPREG00000021691/ENSPREG00000003918/ENSPREG00000004218/ENSPREG00000020193/ENSPREG00000008997/ENSPREG00000013067/ENSPREG00000006372/ENSPREG00000009356/ENSPREG00000000386/ENSPREG00000012184/ENSPREG00000003897/ENSPREG00000010797/ENSPREG00000017870/ENSPREG00000009964/ENSPREG00000023148/ENSPREG00000003440/ENSPREG00000002923/ENSPREG00000013896/ENSPREG00000009540/ENSPREG00000022466/ENSPREG00000018024/ENSPREG00000022696/ENSPREG00000022365/ENSPREG00000014049/ENSPREG00000022088/ENSPREG00000016797/ENSPREG00000008456/ENSPREG00000020203/ENSPREG00000012868/ENSPREG00000005038/ENSPREG00000005223/ENSPREG00000007173/ENSPREG00000022277/ENSPREG00000020685/ENSPREG00000016742/ENSPREG00000005527/ENSPREG00000010381/ENSPREG00000014985/ENSPREG00000018023/ENSPREG00000013858/ENSPREG00000016063/ENSPREG00000018405/ENSPREG00000006464/ENSPREG00000018193/ENSPREG00000021362/ENSPREG00000018972/ENSPREG00000014803/ENSPREG00000000378/ENSPREG00000021553/ENSPREG00000003192/ENSPREG00000022267/ENSPREG00000021274/ENSPREG00000017405/ENSPREG00000007784/ENSPREG00000014523/ENSPREG00000005151/ENSPREG00000015738/ENSPREG00000018925/ENSPREG00000003423/ENSPREG00000010877/ENSPREG00000012529/ENSPREG00000018272/ENSPREG00000018746/ENSPREG00000009131/ENSPREG00000002487/ENSPREG00000007244/ENSPREG00000019470/ENSPREG00000012950/ENSPREG00000016198/ENSPREG00000011482/ENSPREG00000012663/ENSPREG00000012105/ENSPREG00000018630/ENSPREG00000008156/ENSPREG00000008418/ENSPREG00000008711/ENSPREG00000005278/ENSPREG00000005000/ENSPREG00000012965/ENSPREG00000017836/ENSPREG00000004058/ENSPREG00000000531/ENSPREG00000000532/ENSPREG00000001047/ENSPREG00000021700/ENSPREG00000011942/ENSPREG00000000639/ENSPREG00000007498/ENSPREG00000019795/ENSPREG00000015111/ENSPREG00000013601/ENSPREG00000014440/ENSPREG00000015315/ENSPREG00000018564/ENSPREG00000000136/ENSPREG00000001369/ENSPREG00000020625/ENSPREG00000000691/ENSPREG00000006796/ENSPREG00000003891/ENSPREG00000001598/ENSPREG00000016234/ENSPREG00000006038/ENSPREG00000015677/ENSPREG00000004185/ENSPREG00000010135/ENSPREG00000009925/ENSPREG00000015465/ENSPREG00000008666/ENSPREG00000008743/ENSPREG00000011827/ENSPREG00000020416/ENSPREG00000000793/ENSPREG00000015258/ENSPREG00000019319/ENSPREG00000014215/ENSPREG00000008960/ENSPREG00000010768/ENSPREG00000012719/ENSPREG00000020303/ENSPREG00000004213/ENSPREG00000001114/ENSPREG00000000568/ENSPREG00000007804/ENSPREG00000019031/ENSPREG00000013255/ENSPREG00000015981/ENSPREG00000009198/ENSPREG00000018196/ENSPREG00000015905/ENSPREG00000021952/ENSPREG00000008337/ENSPREG00000008276/ENSPREG00000015331/ENSPREG00000006032/ENSPREG00000006079/ENSPREG00000001395/ENSPREG00000014770/ENSPREG00000005288/ENSPREG00000003052/ENSPREG00000020093/ENSPREG00000020466/ENSPREG00000017365/ENSPREG00000002617/ENSPREG00000022194/ENSPREG00000010656/ENSPREG00000002331/ENSPREG00000010895/ENSPREG00000011231/ENSPREG00000000644/ENSPREG00000020796/ENSPREG00000021642/ENSPREG00000008761/ENSPREG00000000227/ENSPREG00000021410/ENSPREG00000017378/ENSPREG00000022485/ENSPREG00000002499/ENSPREG00000019694/ENSPREG00000022223/ENSPREG00000006606/ENSPREG00000005818/ENSPREG00000017291/ENSPREG00000009483/ENSPREG00000000662/ENSPREG00000021495/ENSPREG00000012055/ENSPREG00000006767/ENSPREG00000004782/ENSPREG00000017370/ENSPREG00000001155/ENSPREG00000021835/ENSPREG00000003285/ENSPREG00000005356/ENSPREG00000003764/ENSPREG00000018923/ENSPREG00000014826/ENSPREG00000020464/ENSPREG00000018565/ENSPREG00000006388/ENSPREG00000011196/ENSPREG00000015751/ENSPREG00000017854/ENSPREG00000015075/ENSPREG00000016109/ENSPREG00000019599/ENSPREG00000015503/ENSPREG00000004835/ENSPREG00000000100/ENSPREG00000001897/ENSPREG00000023206/ENSPREG00000003049/ENSPREG00000000694/ENSPREG00000006242/ENSPREG00000021707/ENSPREG00000007951/ENSPREG00000005599/ENSPREG00000020878/ENSPREG00000021865/ENSPREG00000006212/ENSPREG00000010684/ENSPREG00000022906/ENSPREG00000008235/ENSPREG00000022457/ENSPREG00000011388/ENSPREG00000006460/ENSPREG00000002677/ENSPREG00000001500/ENSPREG00000009177/ENSPREG00000004357/ENSPREG00000001222/ENSPREG00000020471/ENSPREG00000014973/ENSPREG00000013848/ENSPREG00000006544/ENSPREG00000017666/ENSPREG00000010486/ENSPREG00000010954/ENSPREG00000012420/ENSPREG00000006249/ENSPREG00000005374/ENSPREG00000006368/ENSPREG00000005136/ENSPREG00000019859/ENSPREG00000010250/ENSPREG00000018463/ENSPREG00000019898/ENSPREG00000018266/ENSPREG00000019315/ENSPREG00000013651/ENSPREG00000007743/ENSPREG00000007210/ENSPREG00000013766/ENSPREG00000019517/ENSPREG00000018366/ENSPREG00000016210/ENSPREG00000015597/ENSPREG00000005401/ENSPREG00000021784/ENSPREG00000005552/ENSPREG00000023092/ENSPREG00000011229/ENSPREG00000016918/ENSPREG00000020100/ENSPREG00000018675/ENSPREG00000002365/ENSPREG00000013087/ENSPREG00000004757/ENSPREG00000006777/ENSPREG00000019836/ENSPREG00000020877/ENSPREG00000004514/ENSPREG00000019394/ENSPREG00000009744/ENSPREG00000021857/ENSPREG00000015884/ENSPREG00000001387/ENSPREG00000004768/ENSPREG00000018793/ENSPREG00000011959/ENSPREG00000004628/ENSPREG00000010182/ENSPREG00000003677/ENSPREG00000015137/ENSPREG00000019858/ENSPREG00000021901/ENSPREG00000008937/ENSPREG00000011707/ENSPREG00000022075/ENSPREG00000016194/ENSPREG00000022711/ENSPREG00000000473/ENSPREG00000010143/ENSPREG00000018761/ENSPREG00000015470/ENSPREG00000020853/ENSPREG00000008500/ENSPREG00000002665/ENSPREG00000008032/ENSPREG00000022924/ENSPREG00000003148/ENSPREG00000017403/ENSPREG00000016149/ENSPREG00000008636/ENSPREG00000022772/ENSPREG00000007026/ENSPREG00000004345/ENSPREG00000001918/ENSPREG00000002123/ENSPREG00000017050/ENSPREG00000008906/ENSPREG00000013887/ENSPREG00000020332/ENSPREG00000000557/ENSPREG00000015203/ENSPREG00000019590/ENSPREG00000003481/ENSPREG00000020178/ENSPREG00000000563/ENSPREG00000021717/ENSPREG00000013122/ENSPREG00000021021/ENSPREG00000000133/ENSPREG00000023222/ENSPREG00000015916/ENSPREG00000016792/ENSPREG00000004901/ENSPREG00000001808/ENSPREG00000009968/ENSPREG00000017363/ENSPREG00000013607/ENSPREG00000005863/ENSPREG00000013636/ENSPREG00000005313/ENSPREG00000018198/ENSPREG00000017309/ENSPREG00000013353/ENSPREG00000014513/ENSPREG00000020443/ENSPREG00000011544/ENSPREG00000009537/ENSPREG00000010244/ENSPREG00000020875/ENSPREG00000004667/ENSPREG00000008787/ENSPREG00000005380/ENSPREG00000011620/ENSPREG00000018087/ENSPREG00000014745/ENSPREG00000007543/ENSPREG00000004066/ENSPREG00000008651/ENSPREG00000013420/ENSPREG00000011213/ENSPREG00000022703/ENSPREG00000001464/ENSPREG00000004436/ENSPREG00000011713/ENSPREG00000009874/ENSPREG00000013386/ENSPREG00000018748/ENSPREG00000006489/ENSPREG00000018601/ENSPREG00000015213/ENSPREG00000014279/ENSPREG00000020534/ENSPREG00000004390/ENSPREG00000003072/ENSPREG00000015854/ENSPREG00000020355/ENSPREG00000014100/ENSPREG00000009334/ENSPREG00000008300/ENSPREG00000008224/ENSPREG00000019762/ENSPREG00000011402/ENSPREG00000013694/ENSPREG00000002489/ENSPREG00000004375/ENSPREG00000004289/ENSPREG00000007149/ENSPREG00000009681/ENSPREG00000013209/ENSPREG00000008658/ENSPREG00000000142/ENSPREG00000019647/ENSPREG00000013455/ENSPREG00000014911/ENSPREG00000007551/ENSPREG00000013058/ENSPREG00000012699/ENSPREG00000001746/ENSPREG00000011922/ENSPREG00000010901/ENSPREG00000018743/ENSPREG00000021907/ENSPREG00000021782/ENSPREG00000009357/ENSPREG00000018533/ENSPREG00000002982/ENSPREG00000004079/ENSPREG00000001340/ENSPREG00000017559/ENSPREG00000022635/ENSPREG00000008785/ENSPREG00000010215/ENSPREG00000020684/ENSPREG00000021773/ENSPREG00000015004/ENSPREG00000001364/ENSPREG00000018868/ENSPREG00000013528/ENSPREG00000017943/ENSPREG00000002472/ENSPREG00000020298/ENSPREG00000003601/ENSPREG00000018054/ENSPREG00000004604/ENSPREG00000002018/ENSPREG00000005287/ENSPREG00000006492/ENSPREG00000013775/ENSPREG00000010190/ENSPREG00000003001/ENSPREG00000001346/ENSPREG00000004743/ENSPREG00000007793/ENSPREG00000020582/ENSPREG00000006140/ENSPREG00000006149/ENSPREG00000006479/ENSPREG00000005343/ENSPREG00000008307/ENSPREG00000019385/ENSPREG00000018224/ENSPREG00000019870/ENSPREG00000006787/ENSPREG00000013188/ENSPREG00000006190/ENSPREG00000008483/ENSPREG00000011305/ENSPREG00000005463/ENSPREG00000022414/ENSPREG00000003013/ENSPREG00000015562/ENSPREG00000007323/ENSPREG00000016107/ENSPREG00000020764/ENSPREG00000003267/ENSPREG00000009731/ENSPREG00000022102/ENSPREG00000022051/ENSPREG00000022073/ENSPREG00000002355/ENSPREG00000005657/ENSPREG00000010783/ENSPREG00000008188/ENSPREG00000013048/ENSPREG00000018100/ENSPREG00000010651/ENSPREG00000016694/ENSPREG00000001397/ENSPREG00000018820/ENSPREG00000017420/ENSPREG00000020816/ENSPREG00000008763/ENSPREG00000009492/ENSPREG00000011517/ENSPREG00000008233/ENSPREG00000021005/ENSPREG00000020811/ENSPREG00000012360/ENSPREG00000008939/ENSPREG00000017295/ENSPREG00000011185/ENSPREG00000019550/ENSPREG00000010863/ENSPREG00000005076/ENSPREG00000012424/ENSPREG00000020390/ENSPREG00000000452/ENSPREG00000008335/ENSPREG00000023202/ENSPREG00000005399/ENSPREG00000002904/ENSPREG00000003735/ENSPREG00000006060/ENSPREG00000021719/ENSPREG00000008971/ENSPREG00000012535/ENSPREG00000019611/ENSPREG00000004380/ENSPREG00000012739/ENSPREG00000003447/ENSPREG00000016244/ENSPREG00000002557/ENSPREG00000000311/ENSPREG00000022174/ENSPREG00000006980/ENSPREG00000019570/ENSPREG00000009008/ENSPREG00000001810/ENSPREG00000006716/ENSPREG00000013447/ENSPREG00000013995/ENSPREG00000002380/ENSPREG00000008141/ENSPREG00000019148/ENSPREG00000014602/ENSPREG00000011038/ENSPREG00000018387/ENSPREG00000019670/ENSPREG00000011689/ENSPREG00000013650/ENSPREG00000016519/ENSPREG00000017727/ENSPREG00000000683/ENSPREG00000011871/ENSPREG00000005851/ENSPREG00000006358/ENSPREG00000004087/ENSPREG00000015280/ENSPREG00000022742/ENSPREG00000018881/ENSPREG00000016517/ENSPREG00000017276/ENSPREG00000008128/ENSPREG00000022182/ENSPREG00000022983/ENSPREG00000017783/ENSPREG00000020349/ENSPREG00000018730/ENSPREG00000006129/ENSPREG00000010720/ENSPREG00000014024/ENSPREG00000013329/ENSPREG00000015679/ENSPREG00000022899/ENSPREG00000009470/ENSPREG00000018976/ENSPREG00000011721/ENSPREG00000009565/ENSPREG00000022086/ENSPREG00000010311/ENSPREG00000004398/ENSPREG00000015073/ENSPREG00000013686/ENSPREG00000014444/ENSPREG00000009305/ENSPREG00000021227/ENSPREG00000002385/ENSPREG00000008992/ENSPREG00000017151/ENSPREG00000011212/ENSPREG00000020505/ENSPREG00000021437/ENSPREG00000007742/ENSPREG00000018278/ENSPREG00000012631/ENSPREG00000017575/ENSPREG00000017552/ENSPREG00000019566/ENSPREG00000008858/ENSPREG00000017296/ENSPREG00000012452/ENSPREG00000020885/ENSPREG00000009725/ENSPREG00000012318/ENSPREG00000011769/ENSPREG00000020961/ENSPREG00000015711/ENSPREG00000010347/ENSPREG00000008109/ENSPREG00000005806/ENSPREG00000017983/ENSPREG00000005945/ENSPREG00000000741/ENSPREG00000018486/ENSPREG00000008008/ENSPREG00000014906/ENSPREG00000005042/ENSPREG00000018056/ENSPREG00000018348/ENSPREG00000004772/ENSPREG00000008242/ENSPREG00000011089/ENSPREG00000003105/ENSPREG00000005893/ENSPREG00000019480/ENSPREG00000007900/ENSPREG00000023141/ENSPREG00000007275/ENSPREG00000004294/ENSPREG00000005213/ENSPREG00000022246/ENSPREG00000008458/ENSPREG00000003566/ENSPREG00000020306/ENSPREG00000023022/ENSPREG00000021407/ENSPREG00000010793/ENSPREG00000020151/ENSPREG00000013155/ENSPREG00000000238/ENSPREG00000006276/ENSPREG00000020918/ENSPREG00000006322/ENSPREG00000002822/ENSPREG00000018417/ENSPREG00000015548/ENSPREG00000006003/ENSPREG00000014924/ENSPREG00000021885/ENSPREG00000006772/ENSPREG00000006214/ENSPREG00000003939/ENSPREG00000011546/ENSPREG00000004545/ENSPREG00000015692/ENSPREG00000013105/ENSPREG00000004425/ENSPREG00000014823/ENSPREG00000019019/ENSPREG00000017901/ENSPREG00000019601/ENSPREG00000011939/ENSPREG00000013115/ENSPREG00000019669/ENSPREG00000019608/ENSPREG00000015599/ENSPREG00000008698/ENSPREG00000014298/ENSPREG00000013840/ENSPREG00000007850/ENSPREG00000009616/ENSPREG00000015366/ENSPREG00000011271/ENSPREG00000019092/ENSPREG00000005887/ENSPREG00000001432/ENSPREG00000011614/ENSPREG00000021145/ENSPREG00000013313/ENSPREG00000007602/ENSPREG00000019568/ENSPREG00000011076/ENSPREG00000002695/ENSPREG00000015440/ENSPREG00000001461/ENSPREG00000006705/ENSPREG00000015810/ENSPREG00000012858/ENSPREG00000002408/ENSPREG00000013881/ENSPREG00000013036/ENSPREG00000001534/ENSPREG00000011938/ENSPREG00000016371/ENSPREG00000014784/ENSPREG00000017386/ENSPREG00000003819/ENSPREG00000003572/ENSPREG00000021088/ENSPREG00000002991/ENSPREG00000016574
## GO:0043565 sequence-specific DNA binding                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                         ENSPREG00000009351/ENSPREG00000012367/ENSPREG00000005028/ENSPREG00000008389/ENSPREG00000015529/ENSPREG00000012188/ENSPREG00000012003/ENSPREG00000016437/ENSPREG00000009356/ENSPREG00000017870/ENSPREG00000009964/ENSPREG00000016797/ENSPREG00000005038/ENSPREG00000014985/ENSPREG00000014803/ENSPREG00000002487/ENSPREG00000012663/ENSPREG00000011942/ENSPREG00000013601/ENSPREG00000014440/ENSPREG00000020625/ENSPREG00000001598/ENSPREG00000015677/ENSPREG00000004185/ENSPREG00000015905/ENSPREG00000005288/ENSPREG00000020466/ENSPREG00000010895/ENSPREG00000011231/ENSPREG00000008761/ENSPREG00000017524/ENSPREG00000014826/ENSPREG00000018565/ENSPREG00000008229/ENSPREG00000000694/ENSPREG00000022906/ENSPREG00000013651/ENSPREG00000023092/ENSPREG00000011725/ENSPREG00000002365/ENSPREG00000013087/ENSPREG00000019394/ENSPREG00000004768/ENSPREG00000016149/ENSPREG00000022772/ENSPREG00000003481/ENSPREG00000015916/ENSPREG00000014745/ENSPREG00000013420/ENSPREG00000018748/ENSPREG00000015213/ENSPREG00000013694/ENSPREG00000013209/ENSPREG00000013455/ENSPREG00000008785/ENSPREG00000015004/ENSPREG00000002018/ENSPREG00000013775/ENSPREG00000006479/ENSPREG00000009731/ENSPREG00000018100/ENSPREG00000017420/ENSPREG00000012360/ENSPREG00000008939/ENSPREG00000006060/ENSPREG00000004380/ENSPREG00000013995/ENSPREG00000018387/ENSPREG00000016519/ENSPREG00000018881/ENSPREG00000017783/ENSPREG00000022899/ENSPREG00000011721/ENSPREG00000013686/ENSPREG00000011212/ENSPREG00000017575/ENSPREG00000008858/ENSPREG00000015711/ENSPREG00000018486/ENSPREG00000018056/ENSPREG00000004772/ENSPREG00000006969/ENSPREG00000022246/ENSPREG00000006322/ENSPREG00000002822/ENSPREG00000011546/ENSPREG00000019601/ENSPREG00000008698/ENSPREG00000013840/ENSPREG00000011938/ENSPREG00000003572
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                             ENSPREG00000021725/ENSPREG00000004660/ENSPREG00000022340/ENSPREG00000012325/ENSPREG00000011115/ENSPREG00000002117/ENSPREG00000011367/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000017205/ENSPREG00000012188/ENSPREG00000005993/ENSPREG00000013196/ENSPREG00000017440/ENSPREG00000013067/ENSPREG00000010797/ENSPREG00000014049/ENSPREG00000020203/ENSPREG00000018023/ENSPREG00000021630/ENSPREG00000003423/ENSPREG00000012105/ENSPREG00000000531/ENSPREG00000000532/ENSPREG00000007498/ENSPREG00000019795/ENSPREG00000006796/ENSPREG00000016234/ENSPREG00000015465/ENSPREG00000000568/ENSPREG00000009198/ENSPREG00000015331/ENSPREG00000010656/ENSPREG00000000644/ENSPREG00000006767/ENSPREG00000017524/ENSPREG00000006388/ENSPREG00000017666/ENSPREG00000010954/ENSPREG00000012420/ENSPREG00000005374/ENSPREG00000010250/ENSPREG00000013766/ENSPREG00000006777/ENSPREG00000019836/ENSPREG00000015884/ENSPREG00000015470/ENSPREG00000008500/ENSPREG00000002123/ENSPREG00000020332/ENSPREG00000000557/ENSPREG00000020178/ENSPREG00000000563/ENSPREG00000021717/ENSPREG00000021021/ENSPREG00000013636/ENSPREG00000013353/ENSPREG00000001953/ENSPREG00000005380/ENSPREG00000011620/ENSPREG00000004436/ENSPREG00000011713/ENSPREG00000014279/ENSPREG00000008300/ENSPREG00000009681/ENSPREG00000013058/ENSPREG00000001340/ENSPREG00000001364/ENSPREG00000020298/ENSPREG00000003001/ENSPREG00000001346/ENSPREG00000006479/ENSPREG00000005343/ENSPREG00000006787/ENSPREG00000010783/ENSPREG00000013048/ENSPREG00000001397/ENSPREG00000008763/ENSPREG00000021719/ENSPREG00000006716/ENSPREG00000019670/ENSPREG00000000683/ENSPREG00000005851/ENSPREG00000017276/ENSPREG00000022983/ENSPREG00000017783/ENSPREG00000020349/ENSPREG00000011721/ENSPREG00000021227/ENSPREG00000013623/ENSPREG00000020505/ENSPREG00000021437/ENSPREG00000011089/ENSPREG00000007900/ENSPREG00000020306/ENSPREG00000021407/ENSPREG00000006276/ENSPREG00000013765/ENSPREG00000021885/ENSPREG00000006772/ENSPREG00000017901/ENSPREG00000006705/ENSPREG00000015810
## GO:0048471 perinuclear region of cytoplasm                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                               ENSPREG00000016990/ENSPREG00000017141/ENSPREG00000010615/ENSPREG00000010109/ENSPREG00000022530/ENSPREG00000020209/ENSPREG00000020303/ENSPREG00000017328/ENSPREG00000005255/ENSPREG00000022295/ENSPREG00000017997/ENSPREG00000000501/ENSPREG00000004048/ENSPREG00000002853/ENSPREG00000006901/ENSPREG00000008950/ENSPREG00000007668/ENSPREG00000006397/ENSPREG00000020052
## GO:0015075 ion transmembrane transporter activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                               ENSPREG00000003778/ENSPREG00000018212/ENSPREG00000005776/ENSPREG00000007011/ENSPREG00000013279/ENSPREG00000013471
## GO:0030513 positive regulation of BMP signaling pathway                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                   ENSPREG00000019287/ENSPREG00000000104/ENSPREG00000014903/ENSPREG00000018051/ENSPREG00000020925/ENSPREG00000022947/ENSPREG00000018278/ENSPREG00000006960
## GO:1902476 chloride transmembrane transport                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                               ENSPREG00000009136/ENSPREG00000011183/ENSPREG00000011910/ENSPREG00000010288/ENSPREG00000001579/ENSPREG00000001701/ENSPREG00000012121/ENSPREG00000005774
## GO:0003700 DNA-binding transcription factor activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                         ENSPREG00000021725/ENSPREG00000009351/ENSPREG00000010341/ENSPREG00000012168/ENSPREG00000012367/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000017205/ENSPREG00000015529/ENSPREG00000012188/ENSPREG00000014446/ENSPREG00000012003/ENSPREG00000021982/ENSPREG00000016437/ENSPREG00000013067/ENSPREG00000009356/ENSPREG00000010797/ENSPREG00000017870/ENSPREG00000009964/ENSPREG00000023148/ENSPREG00000009540/ENSPREG00000016797/ENSPREG00000020203/ENSPREG00000005038/ENSPREG00000014985/ENSPREG00000018193/ENSPREG00000014803/ENSPREG00000021553/ENSPREG00000022267/ENSPREG00000018746/ENSPREG00000002487/ENSPREG00000009502/ENSPREG00000012663/ENSPREG00000012965/ENSPREG00000014392/ENSPREG00000011942/ENSPREG00000013403/ENSPREG00000011496/ENSPREG00000013601/ENSPREG00000014440/ENSPREG00000020625/ENSPREG00000006796/ENSPREG00000001598/ENSPREG00000015677/ENSPREG00000004185/ENSPREG00000000512/ENSPREG00000015465/ENSPREG00000000568/ENSPREG00000015905/ENSPREG00000015331/ENSPREG00000001395/ENSPREG00000005288/ENSPREG00000020466/ENSPREG00000010895/ENSPREG00000011231/ENSPREG00000008761/ENSPREG00000005818/ENSPREG00000012055/ENSPREG00000006767/ENSPREG00000001199/ENSPREG00000014826/ENSPREG00000018565/ENSPREG00000016109/ENSPREG00000000694/ENSPREG00000022906/ENSPREG00000019842/ENSPREG00000001222/ENSPREG00000006368/ENSPREG00000005136/ENSPREG00000019859/ENSPREG00000013651/ENSPREG00000013766/ENSPREG00000016210/ENSPREG00000015597/ENSPREG00000023092/ENSPREG00000011229/ENSPREG00000016918/ENSPREG00000011725/ENSPREG00000013087/ENSPREG00000021303/ENSPREG00000004757/ENSPREG00000006777/ENSPREG00000004514/ENSPREG00000019394/ENSPREG00000004768/ENSPREG00000004628/ENSPREG00000010182/ENSPREG00000023255/ENSPREG00000016149/ENSPREG00000022772/ENSPREG00000020332/ENSPREG00000000557/ENSPREG00000000563/ENSPREG00000021021/ENSPREG00000015916/ENSPREG00000013636/ENSPREG00000014513/ENSPREG00000020875/ENSPREG00000005380/ENSPREG00000014745/ENSPREG00000012212/ENSPREG00000013420/ENSPREG00000013386/ENSPREG00000018748/ENSPREG00000015854/ENSPREG00000019762/ENSPREG00000013694/ENSPREG00000009681/ENSPREG00000013209/ENSPREG00000013058/ENSPREG00000012699/ENSPREG00000021782/ENSPREG00000004079/ENSPREG00000008785/ENSPREG00000020684/ENSPREG00000006621/ENSPREG00000002018/ENSPREG00000013775/ENSPREG00000004743/ENSPREG00000006479/ENSPREG00000019385/ENSPREG00000018224/ENSPREG00000006787/ENSPREG00000009731/ENSPREG00000017420/ENSPREG00000001229/ENSPREG00000008939/ENSPREG00000019278/ENSPREG00000006060/ENSPREG00000004380/ENSPREG00000013995/ENSPREG00000018387/ENSPREG00000016519/ENSPREG00000005851/ENSPREG00000018881/ENSPREG00000022983/ENSPREG00000017783/ENSPREG00000022899/ENSPREG00000011721/ENSPREG00000019546/ENSPREG00000013686/ENSPREG00000011212/ENSPREG00000020505/ENSPREG00000017575/ENSPREG00000019566/ENSPREG00000015711/ENSPREG00000018486/ENSPREG00000004772/ENSPREG00000006969/ENSPREG00000014867/ENSPREG00000019480/ENSPREG00000007900/ENSPREG00000022246/ENSPREG00000017494/ENSPREG00000006322/ENSPREG00000002822/ENSPREG00000021885/ENSPREG00000011546/ENSPREG00000019601/ENSPREG00000011939/ENSPREG00000008698/ENSPREG00000013840/ENSPREG00000001432/ENSPREG00000015810/ENSPREG00000012858/ENSPREG00000011938/ENSPREG00000003572
## GO:0005515 protein binding                                                       ENSPREG00000011953/ENSPREG00000003585/ENSPREG00000012853/ENSPREG00000004055/ENSPREG00000006443/ENSPREG00000020958/ENSPREG00000000164/ENSPREG00000002278/ENSPREG00000010544/ENSPREG00000001363/ENSPREG00000022961/ENSPREG00000002771/ENSPREG00000019101/ENSPREG00000016965/ENSPREG00000010341/ENSPREG00000000900/ENSPREG00000001335/ENSPREG00000000954/ENSPREG00000000312/ENSPREG00000007731/ENSPREG00000017981/ENSPREG00000019186/ENSPREG00000010064/ENSPREG00000017574/ENSPREG00000002476/ENSPREG00000021756/ENSPREG00000006662/ENSPREG00000017062/ENSPREG00000005051/ENSPREG00000022512/ENSPREG00000021269/ENSPREG00000017111/ENSPREG00000012251/ENSPREG00000006194/ENSPREG00000010675/ENSPREG00000003508/ENSPREG00000002457/ENSPREG00000018360/ENSPREG00000007359/ENSPREG00000010264/ENSPREG00000001755/ENSPREG00000022133/ENSPREG00000011250/ENSPREG00000009749/ENSPREG00000012218/ENSPREG00000008576/ENSPREG00000012822/ENSPREG00000022786/ENSPREG00000005421/ENSPREG00000015185/ENSPREG00000021217/ENSPREG00000016656/ENSPREG00000007748/ENSPREG00000004777/ENSPREG00000008770/ENSPREG00000022184/ENSPREG00000012394/ENSPREG00000009526/ENSPREG00000004054/ENSPREG00000020009/ENSPREG00000006259/ENSPREG00000004210/ENSPREG00000001857/ENSPREG00000016455/ENSPREG00000016460/ENSPREG00000010850/ENSPREG00000004636/ENSPREG00000006420/ENSPREG00000007238/ENSPREG00000005549/ENSPREG00000022326/ENSPREG00000022339/ENSPREG00000009984/ENSPREG00000006436/ENSPREG00000008019/ENSPREG00000004557/ENSPREG00000015324/ENSPREG00000018900/ENSPREG00000010906/ENSPREG00000003283/ENSPREG00000009016/ENSPREG00000023140/ENSPREG00000017454/ENSPREG00000021256/ENSPREG00000010905/ENSPREG00000005048/ENSPREG00000017448/ENSPREG00000009775/ENSPREG00000014023/ENSPREG00000003639/ENSPREG00000019504/ENSPREG00000020820/ENSPREG00000007778/ENSPREG00000008779/ENSPREG00000001445/ENSPREG00000009816/ENSPREG00000019197/ENSPREG00000001908/ENSPREG00000009568/ENSPREG00000011786/ENSPREG00000018613/ENSPREG00000021359/ENSPREG00000001707/ENSPREG00000014502/ENSPREG00000018480/ENSPREG00000003918/ENSPREG00000013331/ENSPREG00000015652/ENSPREG00000021494/ENSPREG00000018963/ENSPREG00000000685/ENSPREG00000011284/ENSPREG00000017061/ENSPREG00000006987/ENSPREG00000011331/ENSPREG00000003791/ENSPREG00000006498/ENSPREG00000013511/ENSPREG00000009287/ENSPREG00000020745/ENSPREG00000008863/ENSPREG00000014625/ENSPREG00000014332/ENSPREG00000008038/ENSPREG00000020473/ENSPREG00000022076/ENSPREG00000001939/ENSPREG00000022874/ENSPREG00000000609/ENSPREG00000012617/ENSPREG00000018667/ENSPREG00000004060/ENSPREG00000009991/ENSPREG00000012897/ENSPREG00000020768/ENSPREG00000000778/ENSPREG00000013339/ENSPREG00000016039/ENSPREG00000020999/ENSPREG00000013249/ENSPREG00000006035/ENSPREG00000022557/ENSPREG00000016525/ENSPREG00000022193/ENSPREG00000016649/ENSPREG00000016742/ENSPREG00000020310/ENSPREG00000019287/ENSPREG00000008034/ENSPREG00000020020/ENSPREG00000020573/ENSPREG00000018579/ENSPREG00000006914/ENSPREG00000018739/ENSPREG00000021915/ENSPREG00000009226/ENSPREG00000020590/ENSPREG00000003437/ENSPREG00000013858/ENSPREG00000001868/ENSPREG00000008052/ENSPREG00000017326/ENSPREG00000016063/ENSPREG00000009689/ENSPREG00000018193/ENSPREG00000017413/ENSPREG00000015614/ENSPREG00000008848/ENSPREG00000004374/ENSPREG00000009970/ENSPREG00000000119/ENSPREG00000021215/ENSPREG00000011322/ENSPREG00000006634/ENSPREG00000016838/ENSPREG00000004773/ENSPREG00000002585/ENSPREG00000012167/ENSPREG00000021481/ENSPREG00000014507/ENSPREG00000019656/ENSPREG00000018652/ENSPREG00000019132/ENSPREG00000010109/ENSPREG00000002194/ENSPREG00000018925/ENSPREG00000022191/ENSPREG00000010877/ENSPREG00000004259/ENSPREG00000017070/ENSPREG00000001142/ENSPREG00000004300/ENSPREG00000010225/ENSPREG00000010503/ENSPREG00000013653/ENSPREG00000005178/ENSPREG00000018468/ENSPREG00000014793/ENSPREG00000015578/ENSPREG00000017867/ENSPREG00000022029/ENSPREG00000018630/ENSPREG00000003604/ENSPREG00000002248/ENSPREG00000000125/ENSPREG00000020067/ENSPREG00000002348/ENSPREG00000017042/ENSPREG00000013496/ENSPREG00000012534/ENSPREG00000010160/ENSPREG00000021797/ENSPREG00000013675/ENSPREG00000015865/ENSPREG00000007974/ENSPREG00000019086/ENSPREG00000006294/ENSPREG00000014092/ENSPREG00000006797/ENSPREG00000007324/ENSPREG00000013327/ENSPREG00000010833/ENSPREG00000016362/ENSPREG00000004312/ENSPREG00000022420/ENSPREG00000012550/ENSPREG00000022289/ENSPREG00000016312/ENSPREG00000020729/ENSPREG00000002145/ENSPREG00000019855/ENSPREG00000001211/ENSPREG00000007903/ENSPREG00000004039/ENSPREG00000003645/ENSPREG00000016756/ENSPREG00000015315/ENSPREG00000020923/ENSPREG00000019248/ENSPREG00000022372/ENSPREG00000017615/ENSPREG00000013611/ENSPREG00000003891/ENSPREG00000015801/ENSPREG00000003542/ENSPREG00000021106/ENSPREG00000003558/ENSPREG00000010978/ENSPREG00000004149/ENSPREG00000017179/ENSPREG00000008818/ENSPREG00000014516/ENSPREG00000006673/ENSPREG00000010595/ENSPREG00000015791/ENSPREG00000006962/ENSPREG00000021539/ENSPREG00000010337/ENSPREG00000001779/ENSPREG00000007565/ENSPREG00000007331/ENSPREG00000014483/ENSPREG00000007218/ENSPREG00000021575/ENSPREG00000005611/ENSPREG00000000341/ENSPREG00000000779/ENSPREG00000017751/ENSPREG00000018891/ENSPREG00000017444/ENSPREG00000002366/ENSPREG00000015258/ENSPREG00000019319/ENSPREG00000011127/ENSPREG00000016459/ENSPREG00000012958/ENSPREG00000000598/ENSPREG00000007319/ENSPREG00000000130/ENSPREG00000018168/ENSPREG00000023130/ENSPREG00000003538/ENSPREG00000010253/ENSPREG00000009748/ENSPREG00000018357/ENSPREG00000020450/ENSPREG00000002792/ENSPREG00000003800/ENSPREG00000016483/ENSPREG00000006438/ENSPREG00000012231/ENSPREG00000016682/ENSPREG00000018477/ENSPREG00000000498/ENSPREG00000017820/ENSPREG00000012402/ENSPREG00000015306/ENSPREG00000003789/ENSPREG00000007632/ENSPREG00000002536/ENSPREG00000007006/ENSPREG00000015905/ENSPREG00000022828/ENSPREG00000001070/ENSPREG00000013271/ENSPREG00000006403/ENSPREG00000004343/ENSPREG00000020515/ENSPREG00000012225/ENSPREG00000013733/ENSPREG00000017328/ENSPREG00000014807/ENSPREG00000016967/ENSPREG00000013044/ENSPREG00000019090/ENSPREG00000004228/ENSPREG00000022838/ENSPREG00000019860/ENSPREG00000003161/ENSPREG00000018661/ENSPREG00000017365/ENSPREG00000019790/ENSPREG00000002917/ENSPREG00000019982/ENSPREG00000000629/ENSPREG00000006781/ENSPREG00000003290/ENSPREG00000020137/ENSPREG00000002735/ENSPREG00000018854/ENSPREG00000007262/ENSPREG00000004021/ENSPREG00000000588/ENSPREG00000000485/ENSPREG00000004632/ENSPREG00000019282/ENSPREG00000017951/ENSPREG00000020325/ENSPREG00000010697/ENSPREG00000009084/ENSPREG00000016523/ENSPREG00000008775/ENSPREG00000008786/ENSPREG00000007493/ENSPREG00000005420/ENSPREG00000022223/ENSPREG00000003169/ENSPREG00000009811/ENSPREG00000002766/ENSPREG00000022877/ENSPREG00000013687/ENSPREG00000018567/ENSPREG00000018440/ENSPREG00000008123/ENSPREG00000016650/ENSPREG00000016750/ENSPREG00000018609/ENSPREG00000020959/ENSPREG00000001407/ENSPREG00000019707/ENSPREG00000007789/ENSPREG00000009060/ENSPREG00000021856/ENSPREG00000020680/ENSPREG00000009420/ENSPREG00000018413/ENSPREG00000010270/ENSPREG00000014937/ENSPREG00000018664/ENSPREG00000010883/ENSPREG00000015764/ENSPREG00000018397/ENSPREG00000014672/ENSPREG00000007053/ENSPREG00000011196/ENSPREG00000015338/ENSPREG00000013074/ENSPREG00000020439/ENSPREG00000015075/ENSPREG00000019585/ENSPREG00000015346/ENSPREG00000016331/ENSPREG00000001436/ENSPREG00000011068/ENSPREG00000006820/ENSPREG00000001060/ENSPREG00000011431/ENSPREG00000011949/ENSPREG00000021865/ENSPREG00000012273/ENSPREG00000002972/ENSPREG00000014047/ENSPREG00000004576/ENSPREG00000006212/ENSPREG00000021455/ENSPREG00000022197/ENSPREG00000021205/ENSPREG00000022224/ENSPREG00000010089/ENSPREG00000001752/ENSPREG00000003965/ENSPREG00000002677/ENSPREG00000001500/ENSPREG00000009177/ENSPREG00000020822/ENSPREG00000008369/ENSPREG00000014973/ENSPREG00000018382/ENSPREG00000001103/ENSPREG00000002254/ENSPREG00000018823/ENSPREG00000006544/ENSPREG00000017366/ENSPREG00000010853/ENSPREG00000010858/ENSPREG00000022805/ENSPREG00000010817/ENSPREG00000011132/ENSPREG00000006025/ENSPREG00000005148/ENSPREG00000019039/ENSPREG00000005192/ENSPREG00000022668/ENSPREG00000013763/ENSPREG00000018266/ENSPREG00000017085/ENSPREG00000017018/ENSPREG00000015714/ENSPREG00000016542/ENSPREG00000001716/ENSPREG00000010039/ENSPREG00000012552/ENSPREG00000003515/ENSPREG00000014312/ENSPREG00000020669/ENSPREG00000018452/ENSPREG00000012989/ENSPREG00000018366/ENSPREG00000021218/ENSPREG00000015597/ENSPREG00000018361/ENSPREG00000014068/ENSPREG00000000638/ENSPREG00000000041/ENSPREG00000018926/ENSPREG00000006387/ENSPREG00000021765/ENSPREG00000011036/ENSPREG00000007582/ENSPREG00000002613/ENSPREG00000014065/ENSPREG00000009142/ENSPREG00000021158/ENSPREG00000007156/ENSPREG00000016621/ENSPREG00000018675/ENSPREG00000021550/ENSPREG00000022746/ENSPREG00000015956/ENSPREG00000004073/ENSPREG00000016118/ENSPREG00000018291/ENSPREG00000005026/ENSPREG00000006669/ENSPREG00000023229/ENSPREG00000023230/ENSPREG00000010400/ENSPREG00000021766/ENSPREG00000019394/ENSPREG00000005952/ENSPREG00000018173/ENSPREG00000011959/ENSPREG00000011957/ENSPREG00000010712/ENSPREG00000002171/ENSPREG00000003313/ENSPREG00000000688/ENSPREG00000001809/ENSPREG00000008648/ENSPREG00000004565/ENSPREG00000010345/ENSPREG00000005875/ENSPREG00000003677/ENSPREG00000018877/ENSPREG00000014041/ENSPREG00000018764/ENSPREG00000019858/ENSPREG00000017741/ENSPREG00000023155/ENSPREG00000001257/ENSPREG00000004963/ENSPREG00000021439/ENSPREG00000022257/ENSPREG00000023048/ENSPREG00000021901/ENSPREG00000003852/ENSPREG00000000473/ENSPREG00000009614/ENSPREG00000022808/ENSPREG00000011946/ENSPREG00000004067/ENSPREG00000018109/ENSPREG00000004566/ENSPREG00000011365/ENSPREG00000019135/ENSPREG00000015843/ENSPREG00000012147/ENSPREG00000021731/ENSPREG00000002598/ENSPREG00000022344/ENSPREG00000010201/ENSPREG00000000237/ENSPREG00000008086/ENSPREG00000009992/ENSPREG00000010914/ENSPREG00000022132/ENSPREG00000004587/ENSPREG00000011776/ENSPREG00000000802/ENSPREG00000000860/ENSPREG00000002240/ENSPREG00000021179/ENSPREG00000021917/ENSPREG00000001918/ENSPREG00000003732/ENSPREG00000001091/ENSPREG00000014903/ENSPREG00000018329/ENSPREG00000015691/ENSPREG00000021634/ENSPREG00000021653/ENSPREG00000012615/ENSPREG00000010979/ENSPREG00000022506/ENSPREG00000008410/ENSPREG00000022413/ENSPREG00000007226/ENSPREG00000015203/ENSPREG00000019686/ENSPREG00000021438/ENSPREG00000015181/ENSPREG00000015724/ENSPREG00000005185/ENSPREG00000015048/ENSPREG00000003556/ENSPREG00000015829/ENSPREG00000003150/ENSPREG00000004187/ENSPREG00000023222/ENSPREG00000002029/ENSPREG00000015925/ENSPREG00000005556/ENSPREG00000014079/ENSPREG00000019833/ENSPREG00000013019/ENSPREG00000004711/ENSPREG00000015447/ENSPREG00000020410/ENSPREG00000017655/ENSPREG00000009378/ENSPREG00000006391/ENSPREG00000021927/ENSPREG00000011314/ENSPREG00000010543/ENSPREG00000023076/ENSPREG00000010790/ENSPREG00000005355/ENSPREG00000010742/ENSPREG00000015049/ENSPREG00000004424/ENSPREG00000013078/ENSPREG00000007271/ENSPREG00000004106/ENSPREG00000021275/ENSPREG00000006188/ENSPREG00000019244/ENSPREG00000011544/ENSPREG00000009537/ENSPREG00000010315/ENSPREG00000005211/ENSPREG00000001419/ENSPREG00000017121/ENSPREG00000018231/ENSPREG00000008155/ENSPREG00000003728/ENSPREG00000012212/ENSPREG00000009864/ENSPREG00000013262/ENSPREG00000001690/ENSPREG00000008737/ENSPREG00000021811/ENSPREG00000011213/ENSPREG00000022505/ENSPREG00000009745/ENSPREG00000006354/ENSPREG00000001415/ENSPREG00000016753/ENSPREG00000000681/ENSPREG00000017705/ENSPREG00000021213/ENSPREG00000005053/ENSPREG00000019089/ENSPREG00000004560/ENSPREG00000011179/ENSPREG00000011758/ENSPREG00000015467/ENSPREG00000011701/ENSPREG00000017329/ENSPREG00000015671/ENSPREG00000008982/ENSPREG00000021573/ENSPREG00000013344/ENSPREG00000011050/ENSPREG00000000279/ENSPREG00000016036/ENSPREG00000008915/ENSPREG00000007092/ENSPREG00000004354/ENSPREG00000021545/ENSPREG00000002074/ENSPREG00000011176/ENSPREG00000020693/ENSPREG00000014100/ENSPREG00000012528/ENSPREG00000006028/ENSPREG00000019567/ENSPREG00000008224/ENSPREG00000015236/ENSPREG00000004796/ENSPREG00000002489/ENSPREG00000002834/ENSPREG00000003121/ENSPREG00000004375/ENSPREG00000018352/ENSPREG00000012811/ENSPREG00000020457/ENSPREG00000017408/ENSPREG00000022386/ENSPREG00000018426/ENSPREG00000014992/ENSPREG00000007309/ENSPREG00000019505/ENSPREG00000018879/ENSPREG00000009870/ENSPREG00000021150/ENSPREG00000012699/ENSPREG00000009248/ENSPREG00000015672/ENSPREG00000016215/ENSPREG00000020147/ENSPREG00000000217/ENSPREG00000007516/ENSPREG00000014772/ENSPREG00000004722/ENSPREG00000014260/ENSPREG00000019594/ENSPREG00000012037/ENSPREG00000013300/ENSPREG00000021009/ENSPREG00000018533/ENSPREG00000022222/ENSPREG00000015288/ENSPREG00000015988/ENSPREG00000021066/ENSPREG00000007785/ENSPREG00000004754/ENSPREG00000022687/ENSPREG00000012783/ENSPREG00000015074/ENSPREG00000021291/ENSPREG00000002035/ENSPREG00000022641/ENSPREG00000011567/ENSPREG00000010172/ENSPREG00000001482/ENSPREG00000004150/ENSPREG00000021638/ENSPREG00000018430/ENSPREG00000000581/ENSPREG00000000589/ENSPREG00000012430/ENSPREG00000020891/ENSPREG00000018815/ENSPREG00000014790/ENSPREG00000012361/ENSPREG00000004700/ENSPREG00000002362/ENSPREG00000020660/ENSPREG00000020749/ENSPREG00000017038/ENSPREG00000004874/ENSPREG00000017608/ENSPREG00000005525/ENSPREG00000002472/ENSPREG00000022353/ENSPREG00000005289/ENSPREG00000003601/ENSPREG00000003584/ENSPREG00000002203/ENSPREG00000010965/ENSPREG00000020970/ENSPREG00000015822/ENSPREG00000000107/ENSPREG00000018410/ENSPREG00000022933/ENSPREG00000012566/ENSPREG00000021620/ENSPREG00000021425/ENSPREG00000005590/ENSPREG00000016104/ENSPREG00000014040/ENSPREG00000020493/ENSPREG00000007793/ENSPREG00000016174/ENSPREG00000007852/ENSPREG00000007468/ENSPREG00000002908/ENSPREG00000001286/ENSPREG00000008665/ENSPREG00000001239/ENSPREG00000019151/ENSPREG00000007039/ENSPREG00000018073/ENSPREG00000015138/ENSPREG00000005463/ENSPREG00000007711/ENSPREG00000012133/ENSPREG00000021435/ENSPREG00000022493/ENSPREG00000019273/ENSPREG00000005614/ENSPREG00000005687/ENSPREG00000020654/ENSPREG00000016333/ENSPREG00000015265/ENSPREG00000006193/ENSPREG00000022876/ENSPREG00000014591/ENSPREG00000013118/ENSPREG00000019390/ENSPREG00000019034/ENSPREG00000018987/ENSPREG00000002183/ENSPREG00000012276/ENSPREG00000018531/ENSPREG00000011954/ENSPREG00000006834/ENSPREG00000016100/ENSPREG00000016138/ENSPREG00000010157/ENSPREG00000008798/ENSPREG00000004552/ENSPREG00000017699/ENSPREG00000017770/ENSPREG00000005156/ENSPREG00000020859/ENSPREG00000005163/ENSPREG00000012360/ENSPREG00000002971/ENSPREG00000018185/ENSPREG00000006253/ENSPREG00000006918/ENSPREG00000003963/ENSPREG00000011185/ENSPREG00000005208/ENSPREG00000007423/ENSPREG00000019550/ENSPREG00000010863/ENSPREG00000009732/ENSPREG00000012815/ENSPREG00000008054/ENSPREG00000000375/ENSPREG00000020390/ENSPREG00000020727/ENSPREG00000000452/ENSPREG00000001702/ENSPREG00000003104/ENSPREG00000001247/ENSPREG00000022921/ENSPREG00000010771/ENSPREG00000021138/ENSPREG00000019278/ENSPREG00000014744/ENSPREG00000002936/ENSPREG00000014739/ENSPREG00000006060/ENSPREG00000000191/ENSPREG00000015935/ENSPREG00000010318/ENSPREG00000006218/ENSPREG00000004946/ENSPREG00000004221/ENSPREG00000012500/ENSPREG00000017120/ENSPREG00000006840/ENSPREG00000010056/ENSPREG00000007868/ENSPREG00000001741/ENSPREG00000008623/ENSPREG00000004944/ENSPREG00000021889/ENSPREG00000019283/ENSPREG00000003411/ENSPREG00000022172/ENSPREG00000013942/ENSPREG00000005237/ENSPREG00000021613/ENSPREG00000010169/ENSPREG00000021411/ENSPREG00000001810/ENSPREG00000008367/ENSPREG00000004018/ENSPREG00000016489/ENSPREG00000000752/ENSPREG00000006590/ENSPREG00000000770/ENSPREG00000015859/ENSPREG00000008742/ENSPREG00000019661/ENSPREG00000002380/ENSPREG00000018726/ENSPREG00000008141/ENSPREG00000022577/ENSPREG00000019866/ENSPREG00000004250/ENSPREG00000007668/ENSPREG00000022708/ENSPREG00000020814/ENSPREG00000017801/ENSPREG00000020634/ENSPREG00000008562/ENSPREG00000009307/ENSPREG00000009642/ENSPREG00000021395/ENSPREG00000005315/ENSPREG00000016402/ENSPREG00000017727/ENSPREG00000018540/ENSPREG00000021349/ENSPREG00000013460/ENSPREG00000017407/ENSPREG00000012526/ENSPREG00000002006/ENSPREG00000018390/ENSPREG00000014349/ENSPREG00000010051/ENSPREG00000015340/ENSPREG00000010066/ENSPREG00000000704/ENSPREG00000019675/ENSPREG00000018881/ENSPREG00000010346/ENSPREG00000009088/ENSPREG00000013038/ENSPREG00000019630/ENSPREG00000005541/ENSPREG00000000181/ENSPREG00000022182/ENSPREG00000010443/ENSPREG00000002716/ENSPREG00000017034/ENSPREG00000015301/ENSPREG00000011191/ENSPREG00000006129/ENSPREG00000010720/ENSPREG00000014024/ENSPREG00000005229/ENSPREG00000014454/ENSPREG00000017079/ENSPREG00000015679/ENSPREG00000006711/ENSPREG00000007579/ENSPREG00000021458/ENSPREG00000013872/ENSPREG00000003502/ENSPREG00000011589/ENSPREG00000016757/ENSPREG00000004494/ENSPREG00000010198/ENSPREG00000009239/ENSPREG00000022086/ENSPREG00000020548/ENSPREG00000017143/ENSPREG00000015073/ENSPREG00000022200/ENSPREG00000007756/ENSPREG00000002137/ENSPREG00000012267/ENSPREG00000023057/ENSPREG00000010674/ENSPREG00000011489/ENSPREG00000005665/ENSPREG00000013491/ENSPREG00000004903/ENSPREG00000013392/ENSPREG00000015114/ENSPREG00000022278/ENSPREG00000003282/ENSPREG00000002547/ENSPREG00000004224/ENSPREG00000020089/ENSPREG00000005896/ENSPREG00000011094/ENSPREG00000021437/ENSPREG00000008228/ENSPREG00000022830/ENSPREG00000018047/ENSPREG00000006207/ENSPREG00000013014/ENSPREG00000010921/ENSPREG00000012104/ENSPREG00000006738/ENSPREG00000013899/ENSPREG00000020791/ENSPREG00000014916/ENSPREG00000017575/ENSPREG00000011097/ENSPREG00000017552/ENSPREG00000000819/ENSPREG00000018707/ENSPREG00000022755/ENSPREG00000011027/ENSPREG00000008451/ENSPREG00000013110/ENSPREG00000015532/ENSPREG00000006089/ENSPREG00000013966/ENSPREG00000001319/ENSPREG00000011769/ENSPREG00000013046/ENSPREG00000010347/ENSPREG00000020818/ENSPREG00000020271/ENSPREG00000012860/ENSPREG00000015825/ENSPREG00000003389/ENSPREG00000004360/ENSPREG00000000234/ENSPREG00000016474/ENSPREG00000014906/ENSPREG00000022895/ENSPREG00000020784/ENSPREG00000018807/ENSPREG00000018348/ENSPREG00000004929/ENSPREG00000011636/ENSPREG00000009630/ENSPREG00000008242/ENSPREG00000003662/ENSPREG00000022622/ENSPREG00000010585/ENSPREG00000019499/ENSPREG00000007539/ENSPREG00000003105/ENSPREG00000005893/ENSPREG00000007761/ENSPREG00000013162/ENSPREG00000010808/ENSPREG00000015887/ENSPREG00000023141/ENSPREG00000007301/ENSPREG00000011541/ENSPREG00000022741/ENSPREG00000000060/ENSPREG00000003143/ENSPREG00000018865/ENSPREG00000013503/ENSPREG00000006365/ENSPREG00000011207/ENSPREG00000023022/ENSPREG00000001437/ENSPREG00000011972/ENSPREG00000015991/ENSPREG00000010793/ENSPREG00000007157/ENSPREG00000008917/ENSPREG00000019255/ENSPREG00000005850/ENSPREG00000020808/ENSPREG00000009885/ENSPREG00000020595/ENSPREG00000008974/ENSPREG00000000238/ENSPREG00000009123/ENSPREG00000014636/ENSPREG00000014852/ENSPREG00000019297/ENSPREG00000003995/ENSPREG00000022213/ENSPREG00000019203/ENSPREG00000008195/ENSPREG00000016724/ENSPREG00000005662/ENSPREG00000005671/ENSPREG00000021850/ENSPREG00000011537/ENSPREG00000021406/ENSPREG00000021750/ENSPREG00000019054/ENSPREG00000005812/ENSPREG00000015405/ENSPREG00000014612/ENSPREG00000008883/ENSPREG00000013631/ENSPREG00000014283/ENSPREG00000014924/ENSPREG00000017900/ENSPREG00000021017/ENSPREG00000006779/ENSPREG00000000980/ENSPREG00000013873/ENSPREG00000021491/ENSPREG00000017641/ENSPREG00000014968/ENSPREG00000008676/ENSPREG00000017389/ENSPREG00000014779/ENSPREG00000012120/ENSPREG00000009412/ENSPREG00000013129/ENSPREG00000014823/ENSPREG00000012408/ENSPREG00000018845/ENSPREG00000013955/ENSPREG00000007496/ENSPREG00000001985/ENSPREG00000013115/ENSPREG00000019669/ENSPREG00000022970/ENSPREG00000002327/ENSPREG00000002370/ENSPREG00000002212/ENSPREG00000015244/ENSPREG00000003120/ENSPREG00000006473/ENSPREG00000018632/ENSPREG00000020849/ENSPREG00000002840/ENSPREG00000020125/ENSPREG00000014921/ENSPREG00000011271/ENSPREG00000018511/ENSPREG00000003008/ENSPREG00000015735/ENSPREG00000003361/ENSPREG00000021255/ENSPREG00000002204/ENSPREG00000019965/ENSPREG00000021145/ENSPREG00000011881/ENSPREG00000003309/ENSPREG00000016861/ENSPREG00000007602/ENSPREG00000004335/ENSPREG00000006747/ENSPREG00000000345/ENSPREG00000002215/ENSPREG00000017512/ENSPREG00000015440/ENSPREG00000015428/ENSPREG00000009791/ENSPREG00000002967/ENSPREG00000016699/ENSPREG00000023219/ENSPREG00000019152/ENSPREG00000007744/ENSPREG00000019701/ENSPREG00000014399/ENSPREG00000019792/ENSPREG00000018522/ENSPREG00000009969/ENSPREG00000018499/ENSPREG00000015234/ENSPREG00000007821/ENSPREG00000005933/ENSPREG00000020914/ENSPREG00000006078/ENSPREG00000013539/ENSPREG00000022260/ENSPREG00000003102/ENSPREG00000002408/ENSPREG00000002891/ENSPREG00000006378/ENSPREG00000004459/ENSPREG00000008178/ENSPREG00000002290/ENSPREG00000013085/ENSPREG00000005173/ENSPREG00000020771/ENSPREG00000015436/ENSPREG00000019745/ENSPREG00000010589/ENSPREG00000001330/ENSPREG00000017063/ENSPREG00000022695/ENSPREG00000007082/ENSPREG00000022710/ENSPREG00000019331/ENSPREG00000003359
## GO:0009887 animal organ morphogenesis                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                  ENSPREG00000013601/ENSPREG00000014440/ENSPREG00000006008/ENSPREG00000001620/ENSPREG00000013898/ENSPREG00000011725/ENSPREG00000014489/ENSPREG00000004048/ENSPREG00000008317
## GO:0006355 regulation of transcription, DNA-templated                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                         ENSPREG00000021725/ENSPREG00000004660/ENSPREG00000009351/ENSPREG00000010804/ENSPREG00000022340/ENSPREG00000012325/ENSPREG00000011115/ENSPREG00000012168/ENSPREG00000007342/ENSPREG00000012367/ENSPREG00000002117/ENSPREG00000005028/ENSPREG00000006450/ENSPREG00000011367/ENSPREG00000012582/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000017205/ENSPREG00000015529/ENSPREG00000012188/ENSPREG00000014446/ENSPREG00000013196/ENSPREG00000012003/ENSPREG00000018974/ENSPREG00000017440/ENSPREG00000021982/ENSPREG00000003428/ENSPREG00000016437/ENSPREG00000018613/ENSPREG00000003918/ENSPREG00000008997/ENSPREG00000013067/ENSPREG00000015542/ENSPREG00000009356/ENSPREG00000010797/ENSPREG00000017870/ENSPREG00000009964/ENSPREG00000023148/ENSPREG00000003440/ENSPREG00000009540/ENSPREG00000022365/ENSPREG00000014049/ENSPREG00000022317/ENSPREG00000016797/ENSPREG00000020203/ENSPREG00000005038/ENSPREG00000014985/ENSPREG00000018023/ENSPREG00000018193/ENSPREG00000021630/ENSPREG00000021362/ENSPREG00000014803/ENSPREG00000021553/ENSPREG00000022267/ENSPREG00000010581/ENSPREG00000007784/ENSPREG00000018925/ENSPREG00000003423/ENSPREG00000010877/ENSPREG00000019519/ENSPREG00000018746/ENSPREG00000009131/ENSPREG00000002487/ENSPREG00000012663/ENSPREG00000012105/ENSPREG00000012965/ENSPREG00000000531/ENSPREG00000000532/ENSPREG00000014392/ENSPREG00000008402/ENSPREG00000011942/ENSPREG00000013403/ENSPREG00000011496/ENSPREG00000007498/ENSPREG00000019795/ENSPREG00000013601/ENSPREG00000014440/ENSPREG00000020625/ENSPREG00000000691/ENSPREG00000006796/ENSPREG00000001598/ENSPREG00000021365/ENSPREG00000016234/ENSPREG00000015677/ENSPREG00000004185/ENSPREG00000000512/ENSPREG00000015465/ENSPREG00000015395/ENSPREG00000000568/ENSPREG00000015981/ENSPREG00000009198/ENSPREG00000018196/ENSPREG00000015905/ENSPREG00000008337/ENSPREG00000015331/ENSPREG00000001395/ENSPREG00000005288/ENSPREG00000020466/ENSPREG00000017365/ENSPREG00000010656/ENSPREG00000010895/ENSPREG00000011231/ENSPREG00000000644/ENSPREG00000008761/ENSPREG00000006606/ENSPREG00000005818/ENSPREG00000000662/ENSPREG00000012055/ENSPREG00000006767/ENSPREG00000021835/ENSPREG00000005356/ENSPREG00000001199/ENSPREG00000014826/ENSPREG00000018565/ENSPREG00000006388/ENSPREG00000016109/ENSPREG00000023206/ENSPREG00000000694/ENSPREG00000022906/ENSPREG00000022457/ENSPREG00000019842/ENSPREG00000001222/ENSPREG00000013848/ENSPREG00000006544/ENSPREG00000017666/ENSPREG00000012420/ENSPREG00000005374/ENSPREG00000006368/ENSPREG00000019859/ENSPREG00000010250/ENSPREG00000013651/ENSPREG00000013766/ENSPREG00000018366/ENSPREG00000016210/ENSPREG00000015597/ENSPREG00000023092/ENSPREG00000011229/ENSPREG00000016918/ENSPREG00000013087/ENSPREG00000006777/ENSPREG00000019836/ENSPREG00000004514/ENSPREG00000015884/ENSPREG00000004768/ENSPREG00000011959/ENSPREG00000004628/ENSPREG00000010182/ENSPREG00000023255/ENSPREG00000015470/ENSPREG00000020853/ENSPREG00000008500/ENSPREG00000016149/ENSPREG00000022772/ENSPREG00000018399/ENSPREG00000002123/ENSPREG00000020332/ENSPREG00000000557/ENSPREG00000020178/ENSPREG00000000563/ENSPREG00000021717/ENSPREG00000021021/ENSPREG00000023222/ENSPREG00000015916/ENSPREG00000013636/ENSPREG00000014960/ENSPREG00000013353/ENSPREG00000014513/ENSPREG00000001953/ENSPREG00000011544/ENSPREG00000020875/ENSPREG00000005380/ENSPREG00000011620/ENSPREG00000014745/ENSPREG00000013420/ENSPREG00000004436/ENSPREG00000011713/ENSPREG00000013386/ENSPREG00000018748/ENSPREG00000015213/ENSPREG00000014279/ENSPREG00000015854/ENSPREG00000018134/ENSPREG00000008300/ENSPREG00000008224/ENSPREG00000019762/ENSPREG00000013694/ENSPREG00000009681/ENSPREG00000013209/ENSPREG00000013455/ENSPREG00000003743/ENSPREG00000013058/ENSPREG00000012699/ENSPREG00000011922/ENSPREG00000021782/ENSPREG00000004079/ENSPREG00000001340/ENSPREG00000008785/ENSPREG00000020684/ENSPREG00000022546/ENSPREG00000001364/ENSPREG00000020298/ENSPREG00000002018/ENSPREG00000013775/ENSPREG00000003001/ENSPREG00000001346/ENSPREG00000004743/ENSPREG00000007793/ENSPREG00000006479/ENSPREG00000005343/ENSPREG00000019385/ENSPREG00000018224/ENSPREG00000014517/ENSPREG00000006787/ENSPREG00000008483/ENSPREG00000009731/ENSPREG00000002355/ENSPREG00000010783/ENSPREG00000013048/ENSPREG00000018100/ENSPREG00000001397/ENSPREG00000017420/ENSPREG00000001229/ENSPREG00000008939/ENSPREG00000019550/ENSPREG00000002262/ENSPREG00000019278/ENSPREG00000023202/ENSPREG00000021719/ENSPREG00000004380/ENSPREG00000003447/ENSPREG00000009008/ENSPREG00000009240/ENSPREG00000001810/ENSPREG00000006716/ENSPREG00000016928/ENSPREG00000013995/ENSPREG00000018249/ENSPREG00000019148/ENSPREG00000018387/ENSPREG00000019670/ENSPREG00000016361/ENSPREG00000016519/ENSPREG00000000683/ENSPREG00000005851/ENSPREG00000018881/ENSPREG00000022182/ENSPREG00000022983/ENSPREG00000017783/ENSPREG00000020349/ENSPREG00000006129/ENSPREG00000020804/ENSPREG00000022899/ENSPREG00000011721/ENSPREG00000019546/ENSPREG00000004398/ENSPREG00000013686/ENSPREG00000007997/ENSPREG00000021227/ENSPREG00000013623/ENSPREG00000011212/ENSPREG00000020505/ENSPREG00000021437/ENSPREG00000017575/ENSPREG00000019566/ENSPREG00000008858/ENSPREG00000015711/ENSPREG00000018486/ENSPREG00000018056/ENSPREG00000004772/ENSPREG00000008242/ENSPREG00000011089/ENSPREG00000014867/ENSPREG00000005893/ENSPREG00000019480/ENSPREG00000007900/ENSPREG00000010841/ENSPREG00000022246/ENSPREG00000020306/ENSPREG00000021407/ENSPREG00000017494/ENSPREG00000006276/ENSPREG00000006322/ENSPREG00000002822/ENSPREG00000021885/ENSPREG00000006772/ENSPREG00000011546/ENSPREG00000014823/ENSPREG00000017901/ENSPREG00000019601/ENSPREG00000013955/ENSPREG00000011939/ENSPREG00000008698/ENSPREG00000013840/ENSPREG00000001432/ENSPREG00000006705/ENSPREG00000015810/ENSPREG00000012858/ENSPREG00000011938/ENSPREG00000014784/ENSPREG00000003572
## GO:0006885 regulation of pH                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                               ENSPREG00000008555/ENSPREG00000001326/ENSPREG00000006390/ENSPREG00000015476/ENSPREG00000018068/ENSPREG00000017526/ENSPREG00000009025/ENSPREG00000006340
## GO:0009190 cyclic nucleotide biosynthetic process                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                 ENSPREG00000020922/ENSPREG00000007721/ENSPREG00000009430/ENSPREG00000017629/ENSPREG00000008753/ENSPREG00000018460/ENSPREG00000005428/ENSPREG00000020297/ENSPREG00000002322/ENSPREG00000000314/ENSPREG00000011307/ENSPREG00000010260/ENSPREG00000007085/ENSPREG00000015357/ENSPREG00000009486/ENSPREG00000011289
##                                                                                  Count
## GO:0003677 DNA binding                                                             402
## GO:0007275 multicellular organism development                                      184
## GO:0005634 nucleus                                                                 716
## GO:0043565 sequence-specific DNA binding                                            91
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific   103
## GO:0048471 perinuclear region of cytoplasm                                          19
## GO:0015075 ion transmembrane transporter activity                                    6
## GO:0030513 positive regulation of BMP signaling pathway                              8
## GO:1902476 chloride transmembrane transport                                          8
## GO:0003700 DNA-binding transcription factor activity                               167
## GO:0005515 protein binding                                                        1099
## GO:0009887 animal organ morphogenesis                                                9
## GO:0006355 regulation of transcription, DNA-templated                              300
## GO:0006885 regulation of pH                                                          8
## GO:0009190 cyclic nucleotide biosynthetic process                                   16
library(reshape2)


CvL_up <- subset(CvL,meth.diff>0&qvalue<0.001)
CvL_up <- unique(CvL_up$gene_id)
str(CvL_up)
##  chr [1:541] "ENSPREG00000003617" "ENSPREG00000008406" "ENSPREG00000011953" ...
CvL_dn <- subset(CvL,meth.diff<0&qvalue<0.001)
CvL_dn <- unique(CvL_dn$gene_id)
str(CvL_dn)
##  chr [1:763] "ENSPREG00000014846" "ENSPREG00000010182" "ENSPREG00000012722" ...
CvG_bg <- unique(CvL$gene_id)
str(CvL_bg)
##  chr [1:21581] "ENSPREG00000014846" "ENSPREG00000003617" ...
c_up <- enricher(gene = CvL_up, universe = CvL_bg, minGSSize = 5, maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_up,15)
##                                                                                                                                                                ID
## GO:0001556 oocyte maturation                                                                                                         GO:0001556 oocyte maturation
## GO:0030318 melanocyte differentiation                                                                                       GO:0030318 melanocyte differentiation
## GO:0005938 cell cortex                                                                                                                     GO:0005938 cell cortex
## GO:0001558 regulation of cell growth                                                                                         GO:0001558 regulation of cell growth
## GO:0032559 adenyl ribonucleotide binding                                                                                 GO:0032559 adenyl ribonucleotide binding
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0006306 DNA methylation                                                                                                             GO:0006306 DNA methylation
## GO:0021794 thalamus development                                                                                                   GO:0021794 thalamus development
## GO:0035778 pronephric nephron tubule epithelial cell differentiation                         GO:0035778 pronephric nephron tubule epithelial cell differentiation
## GO:0071425 hematopoietic stem cell proliferation                                                                 GO:0071425 hematopoietic stem cell proliferation
## GO:0000139 Golgi membrane                                                                                                               GO:0000139 Golgi membrane
## GO:0007030 Golgi organization                                                                                                       GO:0007030 Golgi organization
## GO:0043066 negative regulation of apoptotic process                                                           GO:0043066 negative regulation of apoptotic process
## GO:0004703 G protein-coupled receptor kinase activity                                                       GO:0004703 G protein-coupled receptor kinase activity
## GO:0045746 negative regulation of Notch signaling pathway                                               GO:0045746 negative regulation of Notch signaling pathway
##                                                                                                                                                       Description
## GO:0001556 oocyte maturation                                                                                                         GO:0001556 oocyte maturation
## GO:0030318 melanocyte differentiation                                                                                       GO:0030318 melanocyte differentiation
## GO:0005938 cell cortex                                                                                                                     GO:0005938 cell cortex
## GO:0001558 regulation of cell growth                                                                                         GO:0001558 regulation of cell growth
## GO:0032559 adenyl ribonucleotide binding                                                                                 GO:0032559 adenyl ribonucleotide binding
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0006306 DNA methylation                                                                                                             GO:0006306 DNA methylation
## GO:0021794 thalamus development                                                                                                   GO:0021794 thalamus development
## GO:0035778 pronephric nephron tubule epithelial cell differentiation                         GO:0035778 pronephric nephron tubule epithelial cell differentiation
## GO:0071425 hematopoietic stem cell proliferation                                                                 GO:0071425 hematopoietic stem cell proliferation
## GO:0000139 Golgi membrane                                                                                                               GO:0000139 Golgi membrane
## GO:0007030 Golgi organization                                                                                                       GO:0007030 Golgi organization
## GO:0043066 negative regulation of apoptotic process                                                           GO:0043066 negative regulation of apoptotic process
## GO:0004703 G protein-coupled receptor kinase activity                                                       GO:0004703 G protein-coupled receptor kinase activity
## GO:0045746 negative regulation of Notch signaling pathway                                               GO:0045746 negative regulation of Notch signaling pathway
##                                                                                  GeneRatio
## GO:0001556 oocyte maturation                                                         3/452
## GO:0030318 melanocyte differentiation                                                4/452
## GO:0005938 cell cortex                                                               3/452
## GO:0001558 regulation of cell growth                                                 2/452
## GO:0032559 adenyl ribonucleotide binding                                             2/452
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific    14/452
## GO:0006306 DNA methylation                                                           2/452
## GO:0021794 thalamus development                                                      2/452
## GO:0035778 pronephric nephron tubule epithelial cell differentiation                 2/452
## GO:0071425 hematopoietic stem cell proliferation                                     2/452
## GO:0000139 Golgi membrane                                                           10/452
## GO:0007030 Golgi organization                                                        2/452
## GO:0043066 negative regulation of apoptotic process                                  4/452
## GO:0004703 G protein-coupled receptor kinase activity                                2/452
## GO:0045746 negative regulation of Notch signaling pathway                            2/452
##                                                                                    BgRatio
## GO:0001556 oocyte maturation                                                       8/18067
## GO:0030318 melanocyte differentiation                                             29/18067
## GO:0005938 cell cortex                                                            15/18067
## GO:0001558 regulation of cell growth                                               5/18067
## GO:0032559 adenyl ribonucleotide binding                                           5/18067
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 260/18067
## GO:0006306 DNA methylation                                                         6/18067
## GO:0021794 thalamus development                                                    6/18067
## GO:0035778 pronephric nephron tubule epithelial cell differentiation               6/18067
## GO:0071425 hematopoietic stem cell proliferation                                   7/18067
## GO:0000139 Golgi membrane                                                        174/18067
## GO:0007030 Golgi organization                                                      8/18067
## GO:0043066 negative regulation of apoptotic process                               42/18067
## GO:0004703 G protein-coupled receptor kinase activity                             10/18067
## GO:0045746 negative regulation of Notch signaling pathway                         10/18067
##                                                                                        pvalue
## GO:0001556 oocyte maturation                                                     0.0007931732
## GO:0030318 melanocyte differentiation                                            0.0055929837
## GO:0005938 cell cortex                                                           0.0056566310
## GO:0001558 regulation of cell growth                                             0.0059401068
## GO:0032559 adenyl ribonucleotide binding                                         0.0059401068
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.0060448734
## GO:0006306 DNA methylation                                                       0.0087631139
## GO:0021794 thalamus development                                                  0.0087631139
## GO:0035778 pronephric nephron tubule epithelial cell differentiation             0.0087631139
## GO:0071425 hematopoietic stem cell proliferation                                 0.0120663183
## GO:0000139 Golgi membrane                                                        0.0123688203
## GO:0007030 Golgi organization                                                    0.0158240333
## GO:0043066 negative regulation of apoptotic process                              0.0204548415
## GO:0004703 G protein-coupled receptor kinase activity                            0.0246051154
## GO:0045746 negative regulation of Notch signaling pathway                        0.0246051154
##                                                                                   p.adjust
## GO:0001556 oocyte maturation                                                     0.4703517
## GO:0030318 melanocyte differentiation                                            0.5710857
## GO:0005938 cell cortex                                                           0.5710857
## GO:0001558 regulation of cell growth                                             0.5710857
## GO:0032559 adenyl ribonucleotide binding                                         0.5710857
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.5710857
## GO:0006306 DNA methylation                                                       0.5710857
## GO:0021794 thalamus development                                                  0.5710857
## GO:0035778 pronephric nephron tubule epithelial cell differentiation             0.5710857
## GO:0071425 hematopoietic stem cell proliferation                                 0.5710857
## GO:0000139 Golgi membrane                                                        0.5710857
## GO:0007030 Golgi organization                                                    0.5710857
## GO:0043066 negative regulation of apoptotic process                              0.5710857
## GO:0004703 G protein-coupled receptor kinase activity                            0.5710857
## GO:0045746 negative regulation of Notch signaling pathway                        0.5710857
##                                                                                     qvalue
## GO:0001556 oocyte maturation                                                     0.4700595
## GO:0030318 melanocyte differentiation                                            0.5707309
## GO:0005938 cell cortex                                                           0.5707309
## GO:0001558 regulation of cell growth                                             0.5707309
## GO:0032559 adenyl ribonucleotide binding                                         0.5707309
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.5707309
## GO:0006306 DNA methylation                                                       0.5707309
## GO:0021794 thalamus development                                                  0.5707309
## GO:0035778 pronephric nephron tubule epithelial cell differentiation             0.5707309
## GO:0071425 hematopoietic stem cell proliferation                                 0.5707309
## GO:0000139 Golgi membrane                                                        0.5707309
## GO:0007030 Golgi organization                                                    0.5707309
## GO:0043066 negative regulation of apoptotic process                              0.5707309
## GO:0004703 G protein-coupled receptor kinase activity                            0.5707309
## GO:0045746 negative regulation of Notch signaling pathway                        0.5707309
##                                                                                                                                                                                                                                                                                                                                                     geneID
## GO:0001556 oocyte maturation                                                                                                                                                                                                                                                                      ENSPREG00000008256/ENSPREG00000010644/ENSPREG00000006009
## GO:0030318 melanocyte differentiation                                                                                                                                                                                                                                          ENSPREG00000005012/ENSPREG00000016745/ENSPREG00000017205/ENSPREG00000002975
## GO:0005938 cell cortex                                                                                                                                                                                                                                                                            ENSPREG00000006662/ENSPREG00000005482/ENSPREG00000022786
## GO:0001558 regulation of cell growth                                                                                                                                                                                                                                                                                 ENSPREG00000011250/ENSPREG00000015755
## GO:0032559 adenyl ribonucleotide binding                                                                                                                                                                                                                                                                             ENSPREG00000004180/ENSPREG00000014979
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific ENSPREG00000021725/ENSPREG00000004660/ENSPREG00000022340/ENSPREG00000012325/ENSPREG00000011115/ENSPREG00000002117/ENSPREG00000011367/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000017205/ENSPREG00000012188/ENSPREG00000005993/ENSPREG00000013196/ENSPREG00000017440
## GO:0006306 DNA methylation                                                                                                                                                                                                                                                                                           ENSPREG00000014413/ENSPREG00000019660
## GO:0021794 thalamus development                                                                                                                                                                                                                                                                                      ENSPREG00000012325/ENSPREG00000006450
## GO:0035778 pronephric nephron tubule epithelial cell differentiation                                                                                                                                                                                                                                                 ENSPREG00000011115/ENSPREG00000017205
## GO:0071425 hematopoietic stem cell proliferation                                                                                                                                                                                                                                                                     ENSPREG00000010644/ENSPREG00000007211
## GO:0000139 Golgi membrane                                                                                                                                    ENSPREG00000005012/ENSPREG00000015921/ENSPREG00000001442/ENSPREG00000009222/ENSPREG00000021269/ENSPREG00000004517/ENSPREG00000019079/ENSPREG00000008413/ENSPREG00000001938/ENSPREG00000005797
## GO:0007030 Golgi organization                                                                                                                                                                                                                                                                                        ENSPREG00000005491/ENSPREG00000019079
## GO:0043066 negative regulation of apoptotic process                                                                                                                                                                                                                            ENSPREG00000000981/ENSPREG00000008375/ENSPREG00000004394/ENSPREG00000021398
## GO:0004703 G protein-coupled receptor kinase activity                                                                                                                                                                                                                                                                ENSPREG00000014142/ENSPREG00000000525
## GO:0045746 negative regulation of Notch signaling pathway                                                                                                                                                                                                                                                            ENSPREG00000011340/ENSPREG00000010644
##                                                                                  Count
## GO:0001556 oocyte maturation                                                         3
## GO:0030318 melanocyte differentiation                                                4
## GO:0005938 cell cortex                                                               3
## GO:0001558 regulation of cell growth                                                 2
## GO:0032559 adenyl ribonucleotide binding                                             2
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific    14
## GO:0006306 DNA methylation                                                           2
## GO:0021794 thalamus development                                                      2
## GO:0035778 pronephric nephron tubule epithelial cell differentiation                 2
## GO:0071425 hematopoietic stem cell proliferation                                     2
## GO:0000139 Golgi membrane                                                           10
## GO:0007030 Golgi organization                                                        2
## GO:0043066 negative regulation of apoptotic process                                  4
## GO:0004703 G protein-coupled receptor kinase activity                                2
## GO:0045746 negative regulation of Notch signaling pathway                            2
c_dn <- enricher(gene = CvL_dn, universe = CvL_bg, minGSSize = 5,  maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_dn,15)
##                                                                                                                                                                ID
## GO:0007275 multicellular organism development                                                                       GO:0007275 multicellular organism development
## GO:0046716 muscle cell cellular homeostasis                                                                           GO:0046716 muscle cell cellular homeostasis
## GO:0030239 myofibril assembly                                                                                                       GO:0030239 myofibril assembly
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0004383 guanylate cyclase activity                                                                                       GO:0004383 guanylate cyclase activity
## GO:0006182 cGMP biosynthetic process                                                                                         GO:0006182 cGMP biosynthetic process
## GO:0006384 transcription initiation from RNA polymerase III promoter                         GO:0006384 transcription initiation from RNA polymerase III promoter
## GO:0048663 neuron fate commitment                                                                                               GO:0048663 neuron fate commitment
## GO:0090136 epithelial cell-cell adhesion                                                                                 GO:0090136 epithelial cell-cell adhesion
## GO:0003143 embryonic heart tube morphogenesis                                                                       GO:0003143 embryonic heart tube morphogenesis
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules             GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules
## GO:0003376 sphingosine-1-phosphate receptor signaling pathway                                       GO:0003376 sphingosine-1-phosphate receptor signaling pathway
## GO:0015245 fatty acid transmembrane transporter activity                                                 GO:0015245 fatty acid transmembrane transporter activity
## GO:0021536 diencephalon development                                                                                           GO:0021536 diencephalon development
## GO:0032956 regulation of actin cytoskeleton organization                                                 GO:0032956 regulation of actin cytoskeleton organization
##                                                                                                                                                       Description
## GO:0007275 multicellular organism development                                                                       GO:0007275 multicellular organism development
## GO:0046716 muscle cell cellular homeostasis                                                                           GO:0046716 muscle cell cellular homeostasis
## GO:0030239 myofibril assembly                                                                                                       GO:0030239 myofibril assembly
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0004383 guanylate cyclase activity                                                                                       GO:0004383 guanylate cyclase activity
## GO:0006182 cGMP biosynthetic process                                                                                         GO:0006182 cGMP biosynthetic process
## GO:0006384 transcription initiation from RNA polymerase III promoter                         GO:0006384 transcription initiation from RNA polymerase III promoter
## GO:0048663 neuron fate commitment                                                                                               GO:0048663 neuron fate commitment
## GO:0090136 epithelial cell-cell adhesion                                                                                 GO:0090136 epithelial cell-cell adhesion
## GO:0003143 embryonic heart tube morphogenesis                                                                       GO:0003143 embryonic heart tube morphogenesis
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules             GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules
## GO:0003376 sphingosine-1-phosphate receptor signaling pathway                                       GO:0003376 sphingosine-1-phosphate receptor signaling pathway
## GO:0015245 fatty acid transmembrane transporter activity                                                 GO:0015245 fatty acid transmembrane transporter activity
## GO:0021536 diencephalon development                                                                                           GO:0021536 diencephalon development
## GO:0032956 regulation of actin cytoskeleton organization                                                 GO:0032956 regulation of actin cytoskeleton organization
##                                                                                  GeneRatio
## GO:0007275 multicellular organism development                                       31/639
## GO:0046716 muscle cell cellular homeostasis                                          3/639
## GO:0030239 myofibril assembly                                                        4/639
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific    18/639
## GO:0004383 guanylate cyclase activity                                                3/639
## GO:0006182 cGMP biosynthetic process                                                 3/639
## GO:0006384 transcription initiation from RNA polymerase III promoter                 2/639
## GO:0048663 neuron fate commitment                                                    2/639
## GO:0090136 epithelial cell-cell adhesion                                             2/639
## GO:0003143 embryonic heart tube morphogenesis                                        3/639
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules          10/639
## GO:0003376 sphingosine-1-phosphate receptor signaling pathway                        2/639
## GO:0015245 fatty acid transmembrane transporter activity                             2/639
## GO:0021536 diencephalon development                                                  2/639
## GO:0032956 regulation of actin cytoskeleton organization                             2/639
##                                                                                    BgRatio
## GO:0007275 multicellular organism development                                    480/18067
## GO:0046716 muscle cell cellular homeostasis                                        7/18067
## GO:0030239 myofibril assembly                                                     18/18067
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 260/18067
## GO:0004383 guanylate cyclase activity                                             13/18067
## GO:0006182 cGMP biosynthetic process                                              13/18067
## GO:0006384 transcription initiation from RNA polymerase III promoter               5/18067
## GO:0048663 neuron fate commitment                                                  5/18067
## GO:0090136 epithelial cell-cell adhesion                                           5/18067
## GO:0003143 embryonic heart tube morphogenesis                                     14/18067
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules       123/18067
## GO:0003376 sphingosine-1-phosphate receptor signaling pathway                      6/18067
## GO:0015245 fatty acid transmembrane transporter activity                           6/18067
## GO:0021536 diencephalon development                                                6/18067
## GO:0032956 regulation of actin cytoskeleton organization                           6/18067
##                                                                                        pvalue
## GO:0007275 multicellular organism development                                    0.0009733023
## GO:0046716 muscle cell cellular homeostasis                                      0.0013854140
## GO:0030239 myofibril assembly                                                    0.0031926750
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.0052974337
## GO:0004383 guanylate cyclase activity                                            0.0096598443
## GO:0006182 cGMP biosynthetic process                                             0.0096598443
## GO:0006384 transcription initiation from RNA polymerase III promoter             0.0116325036
## GO:0048663 neuron fate commitment                                                0.0116325036
## GO:0090136 epithelial cell-cell adhesion                                         0.0116325036
## GO:0003143 embryonic heart tube morphogenesis                                    0.0119755916
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules       0.0119791788
## GO:0003376 sphingosine-1-phosphate receptor signaling pathway                    0.0170422457
## GO:0015245 fatty acid transmembrane transporter activity                         0.0170422457
## GO:0021536 diencephalon development                                              0.0170422457
## GO:0032956 regulation of actin cytoskeleton organization                         0.0170422457
##                                                                                   p.adjust
## GO:0007275 multicellular organism development                                    0.4376789
## GO:0046716 muscle cell cellular homeostasis                                      0.4376789
## GO:0030239 myofibril assembly                                                    0.4376789
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.4376789
## GO:0004383 guanylate cyclase activity                                            0.4376789
## GO:0006182 cGMP biosynthetic process                                             0.4376789
## GO:0006384 transcription initiation from RNA polymerase III promoter             0.4376789
## GO:0048663 neuron fate commitment                                                0.4376789
## GO:0090136 epithelial cell-cell adhesion                                         0.4376789
## GO:0003143 embryonic heart tube morphogenesis                                    0.4376789
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules       0.4376789
## GO:0003376 sphingosine-1-phosphate receptor signaling pathway                    0.4376789
## GO:0015245 fatty acid transmembrane transporter activity                         0.4376789
## GO:0021536 diencephalon development                                              0.4376789
## GO:0032956 regulation of actin cytoskeleton organization                         0.4376789
##                                                                                     qvalue
## GO:0007275 multicellular organism development                                    0.4182331
## GO:0046716 muscle cell cellular homeostasis                                      0.4182331
## GO:0030239 myofibril assembly                                                    0.4182331
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.4182331
## GO:0004383 guanylate cyclase activity                                            0.4182331
## GO:0006182 cGMP biosynthetic process                                             0.4182331
## GO:0006384 transcription initiation from RNA polymerase III promoter             0.4182331
## GO:0048663 neuron fate commitment                                                0.4182331
## GO:0090136 epithelial cell-cell adhesion                                         0.4182331
## GO:0003143 embryonic heart tube morphogenesis                                    0.4182331
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules       0.4182331
## GO:0003376 sphingosine-1-phosphate receptor signaling pathway                    0.4182331
## GO:0015245 fatty acid transmembrane transporter activity                         0.4182331
## GO:0021536 diencephalon development                                              0.4182331
## GO:0032956 regulation of actin cytoskeleton organization                         0.4182331
##                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        geneID
## GO:0007275 multicellular organism development                                    ENSPREG00000020332/ENSPREG00000000557/ENSPREG00000020178/ENSPREG00000000563/ENSPREG00000021717/ENSPREG00000021021/ENSPREG00000000133/ENSPREG00000023233/ENSPREG00000014079/ENSPREG00000013636/ENSPREG00000010790/ENSPREG00000008016/ENSPREG00000013353/ENSPREG00000021725/ENSPREG00000004106/ENSPREG00000004667/ENSPREG00000005380/ENSPREG00000011620/ENSPREG00000018360/ENSPREG00000004436/ENSPREG00000011713/ENSPREG00000002679/ENSPREG00000008534/ENSPREG00000014279/ENSPREG00000009944/ENSPREG00000011176/ENSPREG00000008300/ENSPREG00000019762/ENSPREG00000009681/ENSPREG00000013209/ENSPREG00000009870
## GO:0046716 muscle cell cellular homeostasis                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                          ENSPREG00000004187/ENSPREG00000020962/ENSPREG00000020904
## GO:0030239 myofibril assembly                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                     ENSPREG00000021266/ENSPREG00000014625/ENSPREG00000004106/ENSPREG00000007149
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                                                                                                                                                                                                                                                        ENSPREG00000020332/ENSPREG00000000557/ENSPREG00000020178/ENSPREG00000000563/ENSPREG00000021717/ENSPREG00000021021/ENSPREG00000013636/ENSPREG00000013353/ENSPREG00000021725/ENSPREG00000001953/ENSPREG00000005380/ENSPREG00000011620/ENSPREG00000004436/ENSPREG00000011713/ENSPREG00000014279/ENSPREG00000017205/ENSPREG00000008300/ENSPREG00000009681
## GO:0004383 guanylate cyclase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000005428/ENSPREG00000020297/ENSPREG00000002322
## GO:0006182 cGMP biosynthetic process                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                 ENSPREG00000005428/ENSPREG00000020297/ENSPREG00000002322
## GO:0006384 transcription initiation from RNA polymerase III promoter                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                    ENSPREG00000021691/ENSPREG00000000142
## GO:0048663 neuron fate commitment                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                       ENSPREG00000004106/ENSPREG00000003743
## GO:0090136 epithelial cell-cell adhesion                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000006377/ENSPREG00000019281
## GO:0003143 embryonic heart tube morphogenesis                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000006261/ENSPREG00000004581/ENSPREG00000014440
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules                                                                                                                                                                                                                                                                                                                                                                                                                      ENSPREG00000017815/ENSPREG00000019028/ENSPREG00000000942/ENSPREG00000020055/ENSPREG00000001576/ENSPREG00000019190/ENSPREG00000001096/ENSPREG00000022217/ENSPREG00000000083/ENSPREG00000010892
## GO:0003376 sphingosine-1-phosphate receptor signaling pathway                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000001253/ENSPREG00000013844
## GO:0015245 fatty acid transmembrane transporter activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000000320/ENSPREG00000015498
## GO:0021536 diencephalon development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                     ENSPREG00000004106/ENSPREG00000004531
## GO:0032956 regulation of actin cytoskeleton organization                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000002964/ENSPREG00000014992
##                                                                                  Count
## GO:0007275 multicellular organism development                                       31
## GO:0046716 muscle cell cellular homeostasis                                          3
## GO:0030239 myofibril assembly                                                        4
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific    18
## GO:0004383 guanylate cyclase activity                                                3
## GO:0006182 cGMP biosynthetic process                                                 3
## GO:0006384 transcription initiation from RNA polymerase III promoter                 2
## GO:0048663 neuron fate commitment                                                    2
## GO:0090136 epithelial cell-cell adhesion                                             2
## GO:0003143 embryonic heart tube morphogenesis                                        3
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules          10
## GO:0003376 sphingosine-1-phosphate receptor signaling pathway                        2
## GO:0015245 fatty acid transmembrane transporter activity                             2
## GO:0021536 diencephalon development                                                  2
## GO:0032956 regulation of actin cytoskeleton organization                             2
CvLunion <- union(CvL_up,CvL_dn)

c_union <- enricher(gene = CvLunion, universe = CvL_bg, minGSSize = 5,  maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_union,15)
##                                                                                                                                                                ID
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0007275 multicellular organism development                                                                       GO:0007275 multicellular organism development
## GO:0001558 regulation of cell growth                                                                                         GO:0001558 regulation of cell growth
## GO:0006384 transcription initiation from RNA polymerase III promoter                         GO:0006384 transcription initiation from RNA polymerase III promoter
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules             GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules
## GO:0015245 fatty acid transmembrane transporter activity                                                 GO:0015245 fatty acid transmembrane transporter activity
## GO:0004383 guanylate cyclase activity                                                                                       GO:0004383 guanylate cyclase activity
## GO:0006182 cGMP biosynthetic process                                                                                         GO:0006182 cGMP biosynthetic process
## GO:0106306 protein serine phosphatase activity                                                                     GO:0106306 protein serine phosphatase activity
## GO:0106307 protein threonine phosphatase activity                                                               GO:0106307 protein threonine phosphatase activity
## GO:0001676 long-chain fatty acid metabolic process                                                             GO:0001676 long-chain fatty acid metabolic process
## GO:0004467 long-chain fatty acid-CoA ligase activity                                                         GO:0004467 long-chain fatty acid-CoA ligase activity
## GO:0015908 fatty acid transport                                                                                                   GO:0015908 fatty acid transport
## GO:0031957 very long-chain fatty acid-CoA ligase activity                                               GO:0031957 very long-chain fatty acid-CoA ligase activity
## GO:0046716 muscle cell cellular homeostasis                                                                           GO:0046716 muscle cell cellular homeostasis
##                                                                                                                                                       Description
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0007275 multicellular organism development                                                                       GO:0007275 multicellular organism development
## GO:0001558 regulation of cell growth                                                                                         GO:0001558 regulation of cell growth
## GO:0006384 transcription initiation from RNA polymerase III promoter                         GO:0006384 transcription initiation from RNA polymerase III promoter
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules             GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules
## GO:0015245 fatty acid transmembrane transporter activity                                                 GO:0015245 fatty acid transmembrane transporter activity
## GO:0004383 guanylate cyclase activity                                                                                       GO:0004383 guanylate cyclase activity
## GO:0006182 cGMP biosynthetic process                                                                                         GO:0006182 cGMP biosynthetic process
## GO:0106306 protein serine phosphatase activity                                                                     GO:0106306 protein serine phosphatase activity
## GO:0106307 protein threonine phosphatase activity                                                               GO:0106307 protein threonine phosphatase activity
## GO:0001676 long-chain fatty acid metabolic process                                                             GO:0001676 long-chain fatty acid metabolic process
## GO:0004467 long-chain fatty acid-CoA ligase activity                                                         GO:0004467 long-chain fatty acid-CoA ligase activity
## GO:0015908 fatty acid transport                                                                                                   GO:0015908 fatty acid transport
## GO:0031957 very long-chain fatty acid-CoA ligase activity                                               GO:0031957 very long-chain fatty acid-CoA ligase activity
## GO:0046716 muscle cell cellular homeostasis                                                                           GO:0046716 muscle cell cellular homeostasis
##                                                                                  GeneRatio
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific   30/1075
## GO:0007275 multicellular organism development                                      47/1075
## GO:0001558 regulation of cell growth                                                3/1075
## GO:0006384 transcription initiation from RNA polymerase III promoter                3/1075
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules         16/1075
## GO:0015245 fatty acid transmembrane transporter activity                            3/1075
## GO:0004383 guanylate cyclase activity                                               4/1075
## GO:0006182 cGMP biosynthetic process                                                4/1075
## GO:0106306 protein serine phosphatase activity                                     10/1075
## GO:0106307 protein threonine phosphatase activity                                  10/1075
## GO:0001676 long-chain fatty acid metabolic process                                  3/1075
## GO:0004467 long-chain fatty acid-CoA ligase activity                                3/1075
## GO:0015908 fatty acid transport                                                     3/1075
## GO:0031957 very long-chain fatty acid-CoA ligase activity                           3/1075
## GO:0046716 muscle cell cellular homeostasis                                         3/1075
##                                                                                    BgRatio
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 260/18067
## GO:0007275 multicellular organism development                                    480/18067
## GO:0001558 regulation of cell growth                                               5/18067
## GO:0006384 transcription initiation from RNA polymerase III promoter               5/18067
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules       123/18067
## GO:0015245 fatty acid transmembrane transporter activity                           6/18067
## GO:0004383 guanylate cyclase activity                                             13/18067
## GO:0006182 cGMP biosynthetic process                                              13/18067
## GO:0106306 protein serine phosphatase activity                                    67/18067
## GO:0106307 protein threonine phosphatase activity                                 67/18067
## GO:0001676 long-chain fatty acid metabolic process                                 7/18067
## GO:0004467 long-chain fatty acid-CoA ligase activity                               7/18067
## GO:0015908 fatty acid transport                                                    7/18067
## GO:0031957 very long-chain fatty acid-CoA ligase activity                          7/18067
## GO:0046716 muscle cell cellular homeostasis                                        7/18067
##                                                                                        pvalue
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.0003955448
## GO:0007275 multicellular organism development                                    0.0005465437
## GO:0001558 regulation of cell growth                                             0.0019184131
## GO:0006384 transcription initiation from RNA polymerase III promoter             0.0019184131
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules       0.0025799120
## GO:0015245 fatty acid transmembrane transporter activity                         0.0036671063
## GO:0004383 guanylate cyclase activity                                            0.0057781554
## GO:0006182 cGMP biosynthetic process                                             0.0057781554
## GO:0106306 protein serine phosphatase activity                                   0.0059975968
## GO:0106307 protein threonine phosphatase activity                                0.0059975968
## GO:0001676 long-chain fatty acid metabolic process                               0.0061344571
## GO:0004467 long-chain fatty acid-CoA ligase activity                             0.0061344571
## GO:0015908 fatty acid transport                                                  0.0061344571
## GO:0031957 very long-chain fatty acid-CoA ligase activity                        0.0061344571
## GO:0046716 muscle cell cellular homeostasis                                      0.0061344571
##                                                                                   p.adjust
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.2683530
## GO:0007275 multicellular organism development                                    0.2683530
## GO:0001558 regulation of cell growth                                             0.4016025
## GO:0006384 transcription initiation from RNA polymerase III promoter             0.4016025
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules       0.4016025
## GO:0015245 fatty acid transmembrane transporter activity                         0.4016025
## GO:0004383 guanylate cyclase activity                                            0.4016025
## GO:0006182 cGMP biosynthetic process                                             0.4016025
## GO:0106306 protein serine phosphatase activity                                   0.4016025
## GO:0106307 protein threonine phosphatase activity                                0.4016025
## GO:0001676 long-chain fatty acid metabolic process                               0.4016025
## GO:0004467 long-chain fatty acid-CoA ligase activity                             0.4016025
## GO:0015908 fatty acid transport                                                  0.4016025
## GO:0031957 very long-chain fatty acid-CoA ligase activity                        0.4016025
## GO:0046716 muscle cell cellular homeostasis                                      0.4016025
##                                                                                     qvalue
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.2640669
## GO:0007275 multicellular organism development                                    0.2640669
## GO:0001558 regulation of cell growth                                             0.3951882
## GO:0006384 transcription initiation from RNA polymerase III promoter             0.3951882
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules       0.3951882
## GO:0015245 fatty acid transmembrane transporter activity                         0.3951882
## GO:0004383 guanylate cyclase activity                                            0.3951882
## GO:0006182 cGMP biosynthetic process                                             0.3951882
## GO:0106306 protein serine phosphatase activity                                   0.3951882
## GO:0106307 protein threonine phosphatase activity                                0.3951882
## GO:0001676 long-chain fatty acid metabolic process                               0.3951882
## GO:0004467 long-chain fatty acid-CoA ligase activity                             0.3951882
## GO:0015908 fatty acid transport                                                  0.3951882
## GO:0031957 very long-chain fatty acid-CoA ligase activity                        0.3951882
## GO:0046716 muscle cell cellular homeostasis                                      0.3951882
##                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        geneID
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                                                                                                                                                                                                                                                                                                                                    ENSPREG00000021725/ENSPREG00000004660/ENSPREG00000022340/ENSPREG00000012325/ENSPREG00000011115/ENSPREG00000002117/ENSPREG00000011367/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000017205/ENSPREG00000012188/ENSPREG00000005993/ENSPREG00000013196/ENSPREG00000017440/ENSPREG00000020332/ENSPREG00000000557/ENSPREG00000020178/ENSPREG00000000563/ENSPREG00000021717/ENSPREG00000021021/ENSPREG00000013636/ENSPREG00000013353/ENSPREG00000001953/ENSPREG00000005380/ENSPREG00000011620/ENSPREG00000004436/ENSPREG00000011713/ENSPREG00000014279/ENSPREG00000008300/ENSPREG00000009681
## GO:0007275 multicellular organism development                                    ENSPREG00000021725/ENSPREG00000004660/ENSPREG00000007669/ENSPREG00000022340/ENSPREG00000012325/ENSPREG00000011115/ENSPREG00000012168/ENSPREG00000007342/ENSPREG00000002117/ENSPREG00000011367/ENSPREG00000012582/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000005482/ENSPREG00000018360/ENSPREG00000016605/ENSPREG00000013196/ENSPREG00000017440/ENSPREG00000020332/ENSPREG00000000557/ENSPREG00000020178/ENSPREG00000000563/ENSPREG00000021717/ENSPREG00000021021/ENSPREG00000000133/ENSPREG00000023233/ENSPREG00000014079/ENSPREG00000013636/ENSPREG00000010790/ENSPREG00000008016/ENSPREG00000013353/ENSPREG00000004106/ENSPREG00000004667/ENSPREG00000005380/ENSPREG00000011620/ENSPREG00000004436/ENSPREG00000011713/ENSPREG00000002679/ENSPREG00000008534/ENSPREG00000014279/ENSPREG00000009944/ENSPREG00000011176/ENSPREG00000008300/ENSPREG00000019762/ENSPREG00000009681/ENSPREG00000013209/ENSPREG00000009870
## GO:0001558 regulation of cell growth                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                 ENSPREG00000011250/ENSPREG00000015755/ENSPREG00000018001
## GO:0006384 transcription initiation from RNA polymerase III promoter                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                 ENSPREG00000021756/ENSPREG00000021691/ENSPREG00000000142
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                    ENSPREG00000019147/ENSPREG00000001576/ENSPREG00000000982/ENSPREG00000001032/ENSPREG00000019006/ENSPREG00000018962/ENSPREG00000001444/ENSPREG00000017815/ENSPREG00000019028/ENSPREG00000000942/ENSPREG00000020055/ENSPREG00000019190/ENSPREG00000001096/ENSPREG00000022217/ENSPREG00000000083/ENSPREG00000010892
## GO:0015245 fatty acid transmembrane transporter activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                             ENSPREG00000015513/ENSPREG00000000320/ENSPREG00000015498
## GO:0004383 guanylate cyclase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                             ENSPREG00000020922/ENSPREG00000005428/ENSPREG00000020297/ENSPREG00000002322
## GO:0006182 cGMP biosynthetic process                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                              ENSPREG00000020922/ENSPREG00000005428/ENSPREG00000020297/ENSPREG00000002322
## GO:0106306 protein serine phosphatase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                  ENSPREG00000012357/ENSPREG00000014983/ENSPREG00000012040/ENSPREG00000021947/ENSPREG00000021264/ENSPREG00000021732/ENSPREG00000009872/ENSPREG00000005151/ENSPREG00000006482/ENSPREG00000021038
## GO:0106307 protein threonine phosphatase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                               ENSPREG00000012357/ENSPREG00000014983/ENSPREG00000012040/ENSPREG00000021947/ENSPREG00000021264/ENSPREG00000021732/ENSPREG00000009872/ENSPREG00000005151/ENSPREG00000006482/ENSPREG00000021038
## GO:0001676 long-chain fatty acid metabolic process                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                   ENSPREG00000015513/ENSPREG00000000320/ENSPREG00000015498
## GO:0004467 long-chain fatty acid-CoA ligase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                 ENSPREG00000015513/ENSPREG00000000320/ENSPREG00000015498
## GO:0015908 fatty acid transport                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                      ENSPREG00000015513/ENSPREG00000000320/ENSPREG00000015498
## GO:0031957 very long-chain fatty acid-CoA ligase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                            ENSPREG00000015513/ENSPREG00000000320/ENSPREG00000015498
## GO:0046716 muscle cell cellular homeostasis                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                          ENSPREG00000004187/ENSPREG00000020962/ENSPREG00000020904
##                                                                                  Count
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific    30
## GO:0007275 multicellular organism development                                       47
## GO:0001558 regulation of cell growth                                                 3
## GO:0006384 transcription initiation from RNA polymerase III promoter                 3
## GO:0007156 homophilic cell adhesion via plasma membrane adhesion molecules          16
## GO:0015245 fatty acid transmembrane transporter activity                             3
## GO:0004383 guanylate cyclase activity                                                4
## GO:0006182 cGMP biosynthetic process                                                 4
## GO:0106306 protein serine phosphatase activity                                      10
## GO:0106307 protein threonine phosphatase activity                                   10
## GO:0001676 long-chain fatty acid metabolic process                                   3
## GO:0004467 long-chain fatty acid-CoA ligase activity                                 3
## GO:0015908 fatty acid transport                                                      3
## GO:0031957 very long-chain fatty acid-CoA ligase activity                            3
## GO:0046716 muscle cell cellular homeostasis                                          3
library(reshape2)


GvL_up <- subset(GvL,meth.diff>0&qvalue<0.05)
GvL_up <- unique(GvL_up$gene_id)
str(GvL_up)
##  chr [1:4176] "ENSPREG00000002699" "ENSPREG00000004582" ...
GvL_dn <- subset(GvL,meth.diff<0&qvalue<0.05)
GvL_dn <- unique(GvL_dn$gene_id)
str(CvL_dn)
##  chr [1:763] "ENSPREG00000014846" "ENSPREG00000010182" "ENSPREG00000012722" ...
GvL_bg <- unique(GvL$gene_id)
str(GvL_bg)
##  chr [1:21615] "ENSPREG00000021468" "ENSPREG00000021490" ...
c_up <- enricher(gene = GvL_up, universe = GvL_bg, minGSSize = 5, maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_up,15)
##                                                                                                                                                                      ID
## GO:0007275 multicellular organism development                                                                             GO:0007275 multicellular organism development
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific       GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0006355 regulation of transcription, DNA-templated                                                             GO:0006355 regulation of transcription, DNA-templated
## GO:0005515 protein binding                                                                                                                   GO:0005515 protein binding
## GO:0005634 nucleus                                                                                                                                   GO:0005634 nucleus
## GO:0007154 cell communication                                                                                                             GO:0007154 cell communication
## GO:0032264 IMP salvage                                                                                                                           GO:0032264 IMP salvage
## GO:0003690 double-stranded DNA binding                                                                                           GO:0003690 double-stranded DNA binding
## GO:0006166 purine ribonucleoside salvage                                                                                       GO:0006166 purine ribonucleoside salvage
## GO:0032012 regulation of ARF protein signal transduction                                                       GO:0032012 regulation of ARF protein signal transduction
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific
## GO:0072015 glomerular visceral epithelial cell development                                                   GO:0072015 glomerular visceral epithelial cell development
## GO:0005244 voltage-gated ion channel activity                                                                             GO:0005244 voltage-gated ion channel activity
## GO:0034765 regulation of ion transmembrane transport                                                               GO:0034765 regulation of ion transmembrane transport
## GO:0003677 DNA binding                                                                                                                           GO:0003677 DNA binding
##                                                                                                                                                             Description
## GO:0007275 multicellular organism development                                                                             GO:0007275 multicellular organism development
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific       GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0006355 regulation of transcription, DNA-templated                                                             GO:0006355 regulation of transcription, DNA-templated
## GO:0005515 protein binding                                                                                                                   GO:0005515 protein binding
## GO:0005634 nucleus                                                                                                                                   GO:0005634 nucleus
## GO:0007154 cell communication                                                                                                             GO:0007154 cell communication
## GO:0032264 IMP salvage                                                                                                                           GO:0032264 IMP salvage
## GO:0003690 double-stranded DNA binding                                                                                           GO:0003690 double-stranded DNA binding
## GO:0006166 purine ribonucleoside salvage                                                                                       GO:0006166 purine ribonucleoside salvage
## GO:0032012 regulation of ARF protein signal transduction                                                       GO:0032012 regulation of ARF protein signal transduction
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific
## GO:0072015 glomerular visceral epithelial cell development                                                   GO:0072015 glomerular visceral epithelial cell development
## GO:0005244 voltage-gated ion channel activity                                                                             GO:0005244 voltage-gated ion channel activity
## GO:0034765 regulation of ion transmembrane transport                                                               GO:0034765 regulation of ion transmembrane transport
## GO:0003677 DNA binding                                                                                                                           GO:0003677 DNA binding
##                                                                                     GeneRatio
## GO:0007275 multicellular organism development                                        134/3497
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific      73/3497
## GO:0006355 regulation of transcription, DNA-templated                                207/3497
## GO:0005515 protein binding                                                           720/3497
## GO:0005634 nucleus                                                                   457/3497
## GO:0007154 cell communication                                                         21/3497
## GO:0032264 IMP salvage                                                                 6/3497
## GO:0003690 double-stranded DNA binding                                                 8/3497
## GO:0006166 purine ribonucleoside salvage                                               5/3497
## GO:0032012 regulation of ARF protein signal transduction                              10/3497
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific    6/3497
## GO:0072015 glomerular visceral epithelial cell development                             8/3497
## GO:0005244 voltage-gated ion channel activity                                         36/3497
## GO:0034765 regulation of ion transmembrane transport                                  36/3497
## GO:0003677 DNA binding                                                               250/3497
##                                                                                        BgRatio
## GO:0007275 multicellular organism development                                        480/18091
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific     260/18091
## GO:0006355 regulation of transcription, DNA-templated                                875/18091
## GO:0005515 protein binding                                                          3397/18091
## GO:0005634 nucleus                                                                  2108/18091
## GO:0007154 cell communication                                                         59/18091
## GO:0032264 IMP salvage                                                                 9/18091
## GO:0003690 double-stranded DNA binding                                                15/18091
## GO:0006166 purine ribonucleoside salvage                                               7/18091
## GO:0032012 regulation of ARF protein signal transduction                              22/18091
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific   10/18091
## GO:0072015 glomerular visceral epithelial cell development                            16/18091
## GO:0005244 voltage-gated ion channel activity                                        127/18091
## GO:0034765 regulation of ion transmembrane transport                                 127/18091
## GO:0003677 DNA binding                                                              1131/18091
##                                                                                           pvalue
## GO:0007275 multicellular organism development                                       2.487405e-06
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific    3.741238e-04
## GO:0006355 regulation of transcription, DNA-templated                               6.693009e-04
## GO:0005515 protein binding                                                          1.321471e-03
## GO:0005634 nucleus                                                                  2.219565e-03
## GO:0007154 cell communication                                                       2.476662e-03
## GO:0032264 IMP salvage                                                              2.544410e-03
## GO:0003690 double-stranded DNA binding                                              3.378246e-03
## GO:0006166 purine ribonucleoside salvage                                            3.985327e-03
## GO:0032012 regulation of ARF protein signal transduction                            4.736909e-03
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific 5.321910e-03
## GO:0072015 glomerular visceral epithelial cell development                          5.620452e-03
## GO:0005244 voltage-gated ion channel activity                                       8.775471e-03
## GO:0034765 regulation of ion transmembrane transport                                8.775471e-03
## GO:0003677 DNA binding                                                              8.883887e-03
##                                                                                        p.adjust
## GO:0007275 multicellular organism development                                       0.003912688
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific    0.294248386
## GO:0006355 regulation of transcription, DNA-templated                               0.350936750
## GO:0005515 protein binding                                                          0.519668407
## GO:0005634 nucleus                                                                  0.571765313
## GO:0007154 cell communication                                                       0.571765313
## GO:0032264 IMP salvage                                                              0.571765313
## GO:0003690 double-stranded DNA binding                                              0.664247531
## GO:0006166 purine ribonucleoside salvage                                            0.696546684
## GO:0032012 regulation of ARF protein signal transduction                            0.736747529
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific 0.736747529
## GO:0072015 glomerular visceral epithelial cell development                          0.736747529
## GO:0005244 voltage-gated ion channel activity                                       0.780951931
## GO:0034765 regulation of ion transmembrane transport                                0.780951931
## GO:0003677 DNA binding                                                              0.780951931
##                                                                                          qvalue
## GO:0007275 multicellular organism development                                       0.003912688
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific    0.294248386
## GO:0006355 regulation of transcription, DNA-templated                               0.350936750
## GO:0005515 protein binding                                                          0.519668407
## GO:0005634 nucleus                                                                  0.571765313
## GO:0007154 cell communication                                                       0.571765313
## GO:0032264 IMP salvage                                                              0.571765313
## GO:0003690 double-stranded DNA binding                                              0.664247531
## GO:0006166 purine ribonucleoside salvage                                            0.696546684
## GO:0032012 regulation of ARF protein signal transduction                            0.736747529
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific 0.736747529
## GO:0072015 glomerular visceral epithelial cell development                          0.736747529
## GO:0005244 voltage-gated ion channel activity                                       0.780951931
## GO:0034765 regulation of ion transmembrane transport                                0.780951931
## GO:0003677 DNA binding                                                              0.780951931
##                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                              geneID
## GO:0007275 multicellular organism development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                     ENSPREG00000020203/ENSPREG00000021322/ENSPREG00000011367/ENSPREG00000001369/ENSPREG00000006929/ENSPREG00000007900/ENSPREG00000021725/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000003088/ENSPREG00000006767/ENSPREG00000012582/ENSPREG00000006315/ENSPREG00000000568/ENSPREG00000002117/ENSPREG00000000612/ENSPREG00000002795/ENSPREG00000011913/ENSPREG00000019795/ENSPREG00000013048/ENSPREG00000021144/ENSPREG00000009481/ENSPREG00000018023/ENSPREG00000019494/ENSPREG00000008962/ENSPREG00000016797/ENSPREG00000009349/ENSPREG00000010250/ENSPREG00000011561/ENSPREG00000013766/ENSPREG00000012325/ENSPREG00000015810/ENSPREG00000018652/ENSPREG00000012105/ENSPREG00000017347/ENSPREG00000007498/ENSPREG00000021106/ENSPREG00000006945/ENSPREG00000007342/ENSPREG00000011441/ENSPREG00000013058/ENSPREG00000006544/ENSPREG00000008377/ENSPREG00000005482/ENSPREG00000001072/ENSPREG00000021474/ENSPREG00000017440/ENSPREG00000011620/ENSPREG00000017582/ENSPREG00000019060/ENSPREG00000016476/ENSPREG00000016256/ENSPREG00000020385/ENSPREG00000023206/ENSPREG00000003325/ENSPREG00000012541/ENSPREG00000000290/ENSPREG00000019816/ENSPREG00000012697/ENSPREG00000022340/ENSPREG00000007061/ENSPREG00000015499/ENSPREG00000006276/ENSPREG00000000081/ENSPREG00000013353/ENSPREG00000012157/ENSPREG00000013812/ENSPREG00000011115/ENSPREG00000020206/ENSPREG00000009183/ENSPREG00000006008/ENSPREG00000018739/ENSPREG00000004544/ENSPREG00000019531/ENSPREG00000019774/ENSPREG00000005380/ENSPREG00000017388/ENSPREG00000006758/ENSPREG00000018360/ENSPREG00000018299/ENSPREG00000014903/ENSPREG00000009731/ENSPREG00000014120/ENSPREG00000020252/ENSPREG00000015465/ENSPREG00000005385/ENSPREG00000014657/ENSPREG00000009131/ENSPREG00000004067/ENSPREG00000006998/ENSPREG00000012420/ENSPREG00000015409/ENSPREG00000018757/ENSPREG00000008022/ENSPREG00000016630/ENSPREG00000008761/ENSPREG00000006631/ENSPREG00000015189/ENSPREG00000014784/ENSPREG00000009250/ENSPREG00000017666/ENSPREG00000002598/ENSPREG00000001334/ENSPREG00000010793/ENSPREG00000010872/ENSPREG00000007418/ENSPREG00000018822/ENSPREG00000016622/ENSPREG00000005412/ENSPREG00000018009/ENSPREG00000017718/ENSPREG00000013196/ENSPREG00000006981/ENSPREG00000008184/ENSPREG00000009155/ENSPREG00000006819/ENSPREG00000006806/ENSPREG00000015450/ENSPREG00000018004/ENSPREG00000021337/ENSPREG00000014891/ENSPREG00000002673/ENSPREG00000019962/ENSPREG00000000133/ENSPREG00000001918/ENSPREG00000011131/ENSPREG00000019762/ENSPREG00000009681/ENSPREG00000009942/ENSPREG00000006796/ENSPREG00000006388/ENSPREG00000002053/ENSPREG00000012707/ENSPREG00000019085
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                         ENSPREG00000020203/ENSPREG00000012188/ENSPREG00000019823/ENSPREG00000011367/ENSPREG00000006929/ENSPREG00000007900/ENSPREG00000021725/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000006767/ENSPREG00000006315/ENSPREG00000013067/ENSPREG00000000568/ENSPREG00000002117/ENSPREG00000009674/ENSPREG00000002795/ENSPREG00000019795/ENSPREG00000013048/ENSPREG00000018023/ENSPREG00000010250/ENSPREG00000013766/ENSPREG00000012325/ENSPREG00000015810/ENSPREG00000012105/ENSPREG00000007498/ENSPREG00000006945/ENSPREG00000011441/ENSPREG00000013058/ENSPREG00000005993/ENSPREG00000008377/ENSPREG00000017440/ENSPREG00000011620/ENSPREG00000021630/ENSPREG00000016256/ENSPREG00000003325/ENSPREG00000012541/ENSPREG00000000290/ENSPREG00000022340/ENSPREG00000006276/ENSPREG00000013353/ENSPREG00000013812/ENSPREG00000011115/ENSPREG00000019531/ENSPREG00000005380/ENSPREG00000006758/ENSPREG00000015465/ENSPREG00000005385/ENSPREG00000014657/ENSPREG00000006998/ENSPREG00000013765/ENSPREG00000012420/ENSPREG00000021486/ENSPREG00000006631/ENSPREG00000015189/ENSPREG00000009250/ENSPREG00000000644/ENSPREG00000017666/ENSPREG00000001334/ENSPREG00000015043/ENSPREG00000021574/ENSPREG00000013196/ENSPREG00000009155/ENSPREG00000006819/ENSPREG00000013623/ENSPREG00000000949/ENSPREG00000006806/ENSPREG00000015450/ENSPREG00000021337/ENSPREG00000019962/ENSPREG00000011131/ENSPREG00000009681/ENSPREG00000006796/ENSPREG00000006388
## GO:0006355 regulation of transcription, DNA-templated                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                  ENSPREG00000020203/ENSPREG00000012188/ENSPREG00000019823/ENSPREG00000011367/ENSPREG00000004628/ENSPREG00000006929/ENSPREG00000003428/ENSPREG00000007900/ENSPREG00000011918/ENSPREG00000021725/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000006767/ENSPREG00000012582/ENSPREG00000006315/ENSPREG00000000922/ENSPREG00000005246/ENSPREG00000013067/ENSPREG00000022267/ENSPREG00000009351/ENSPREG00000018881/ENSPREG00000000568/ENSPREG00000002117/ENSPREG00000009674/ENSPREG00000014960/ENSPREG00000002795/ENSPREG00000011913/ENSPREG00000019795/ENSPREG00000000313/ENSPREG00000013048/ENSPREG00000010086/ENSPREG00000018023/ENSPREG00000021553/ENSPREG00000022723/ENSPREG00000014608/ENSPREG00000011064/ENSPREG00000014097/ENSPREG00000022546/ENSPREG00000003440/ENSPREG00000004029/ENSPREG00000005028/ENSPREG00000016797/ENSPREG00000010250/ENSPREG00000013386/ENSPREG00000017016/ENSPREG00000013766/ENSPREG00000008667/ENSPREG00000008815/ENSPREG00000021316/ENSPREG00000012325/ENSPREG00000017021/ENSPREG00000015810/ENSPREG00000013403/ENSPREG00000011212/ENSPREG00000012105/ENSPREG00000007498/ENSPREG00000006945/ENSPREG00000016676/ENSPREG00000007342/ENSPREG00000009326/ENSPREG00000011441/ENSPREG00000019519/ENSPREG00000013058/ENSPREG00000006544/ENSPREG00000008377/ENSPREG00000007906/ENSPREG00000017440/ENSPREG00000011620/ENSPREG00000017582/ENSPREG00000003918/ENSPREG00000015905/ENSPREG00000017247/ENSPREG00000011942/ENSPREG00000010162/ENSPREG00000018925/ENSPREG00000019566/ENSPREG00000021630/ENSPREG00000001543/ENSPREG00000016256/ENSPREG00000022772/ENSPREG00000023206/ENSPREG00000003325/ENSPREG00000012541/ENSPREG00000023148/ENSPREG00000011231/ENSPREG00000000290/ENSPREG00000017649/ENSPREG00000015654/ENSPREG00000016146/ENSPREG00000003063/ENSPREG00000015395/ENSPREG00000018974/ENSPREG00000007429/ENSPREG00000022340/ENSPREG00000011269/ENSPREG00000007997/ENSPREG00000015499/ENSPREG00000017887/ENSPREG00000006276/ENSPREG00000002822/ENSPREG00000013353/ENSPREG00000021982/ENSPREG00000022365/ENSPREG00000010841/ENSPREG00000009008/ENSPREG00000023244/ENSPREG00000017352/ENSPREG00000013812/ENSPREG00000011115/ENSPREG00000022066/ENSPREG00000011877/ENSPREG00000021136/ENSPREG00000019531/ENSPREG00000020804/ENSPREG00000004768/ENSPREG00000004398/ENSPREG00000005380/ENSPREG00000012965/ENSPREG00000002259/ENSPREG00000006758/ENSPREG00000009056/ENSPREG00000009731/ENSPREG00000001226/ENSPREG00000014803/ENSPREG00000015465/ENSPREG00000021052/ENSPREG00000018746/ENSPREG00000005385/ENSPREG00000014657/ENSPREG00000009131/ENSPREG00000011496/ENSPREG00000008402/ENSPREG00000011930/ENSPREG00000022910/ENSPREG00000002926/ENSPREG00000008997/ENSPREG00000006998/ENSPREG00000021362/ENSPREG00000012420/ENSPREG00000008972/ENSPREG00000010182/ENSPREG00000019537/ENSPREG00000020466/ENSPREG00000015409/ENSPREG00000000847/ENSPREG00000008918/ENSPREG00000022501/ENSPREG00000008761/ENSPREG00000018558/ENSPREG00000000792/ENSPREG00000006455/ENSPREG00000011189/ENSPREG00000006631/ENSPREG00000007784/ENSPREG00000015189/ENSPREG00000017365/ENSPREG00000007884/ENSPREG00000014784/ENSPREG00000009250/ENSPREG00000000644/ENSPREG00000017666/ENSPREG00000000434/ENSPREG00000001334/ENSPREG00000015981/ENSPREG00000011732/ENSPREG00000021574/ENSPREG00000014207/ENSPREG00000013196/ENSPREG00000020992/ENSPREG00000010818/ENSPREG00000003680/ENSPREG00000016863/ENSPREG00000022630/ENSPREG00000005038/ENSPREG00000009155/ENSPREG00000005008/ENSPREG00000006819/ENSPREG00000013848/ENSPREG00000013623/ENSPREG00000022317/ENSPREG00000009052/ENSPREG00000010581/ENSPREG00000013800/ENSPREG00000006806/ENSPREG00000011546/ENSPREG00000018249/ENSPREG00000015450/ENSPREG00000018193/ENSPREG00000009850/ENSPREG00000022410/ENSPREG00000021337/ENSPREG00000019455/ENSPREG00000019962/ENSPREG00000010102/ENSPREG00000011131/ENSPREG00000019762/ENSPREG00000011387/ENSPREG00000005818/ENSPREG00000009681/ENSPREG00000018056/ENSPREG00000011677/ENSPREG00000006796/ENSPREG00000006388/ENSPREG00000002487/ENSPREG00000018453/ENSPREG00000011959/ENSPREG00000004232
## GO:0005515 protein binding                                                          ENSPREG00000004594/ENSPREG00000011953/ENSPREG00000012251/ENSPREG00000005998/ENSPREG00000012853/ENSPREG00000018477/ENSPREG00000019319/ENSPREG00000021322/ENSPREG00000001335/ENSPREG00000015471/ENSPREG00000017867/ENSPREG00000005048/ENSPREG00000002585/ENSPREG00000012822/ENSPREG00000006498/ENSPREG00000006662/ENSPREG00000009060/ENSPREG00000022512/ENSPREG00000013014/ENSPREG00000006443/ENSPREG00000014506/ENSPREG00000017977/ENSPREG00000012897/ENSPREG00000020661/ENSPREG00000021152/ENSPREG00000001239/ENSPREG00000007778/ENSPREG00000017204/ENSPREG00000002248/ENSPREG00000019970/ENSPREG00000020137/ENSPREG00000001142/ENSPREG00000009748/ENSPREG00000008576/ENSPREG00000016967/ENSPREG00000009420/ENSPREG00000023130/ENSPREG00000021756/ENSPREG00000012860/ENSPREG00000019090/ENSPREG00000004636/ENSPREG00000005315/ENSPREG00000001734/ENSPREG00000018881/ENSPREG00000002194/ENSPREG00000013460/ENSPREG00000017713/ENSPREG00000004055/ENSPREG00000003556/ENSPREG00000014973/ENSPREG00000011222/ENSPREG00000018815/ENSPREG00000021689/ENSPREG00000013339/ENSPREG00000010675/ENSPREG00000015324/ENSPREG00000006112/ENSPREG00000000629/ENSPREG00000019123/ENSPREG00000003610/ENSPREG00000012466/ENSPREG00000020310/ENSPREG00000000313/ENSPREG00000002366/ENSPREG00000013162/ENSPREG00000018168/ENSPREG00000009555/ENSPREG00000010398/ENSPREG00000012620/ENSPREG00000022961/ENSPREG00000018867/ENSPREG00000004777/ENSPREG00000022326/ENSPREG00000022339/ENSPREG00000009493/ENSPREG00000022133/ENSPREG00000019390/ENSPREG00000022366/ENSPREG00000019952/ENSPREG00000021215/ENSPREG00000006634/ENSPREG00000007157/ENSPREG00000016525/ENSPREG00000011896/ENSPREG00000009469/ENSPREG00000003508/ENSPREG00000003290/ENSPREG00000011758/ENSPREG00000000685/ENSPREG00000010125/ENSPREG00000006987/ENSPREG00000021622/ENSPREG00000002476/ENSPREG00000014608/ENSPREG00000001983/ENSPREG00000011064/ENSPREG00000001980/ENSPREG00000008778/ENSPREG00000000341/ENSPREG00000015155/ENSPREG00000020009/ENSPREG00000010341/ENSPREG00000017454/ENSPREG00000012413/ENSPREG00000014822/ENSPREG00000004263/ENSPREG00000008123/ENSPREG00000021865/ENSPREG00000020140/ENSPREG00000022616/ENSPREG00000004029/ENSPREG00000005051/ENSPREG00000019340/ENSPREG00000009666/ENSPREG00000004300/ENSPREG00000015991/ENSPREG00000011159/ENSPREG00000000588/ENSPREG00000010064/ENSPREG00000017657/ENSPREG00000006440/ENSPREG00000004736/ENSPREG00000022808/ENSPREG00000005875/ENSPREG00000000164/ENSPREG00000015245/ENSPREG00000011352/ENSPREG00000007731/ENSPREG00000001779/ENSPREG00000000954/ENSPREG00000014507/ENSPREG00000022767/ENSPREG00000007331/ENSPREG00000021401/ENSPREG00000006028/ENSPREG00000011331/ENSPREG00000015478/ENSPREG00000004312/ENSPREG00000022344/ENSPREG00000009801/ENSPREG00000000217/ENSPREG00000022594/ENSPREG00000018440/ENSPREG00000011036/ENSPREG00000013046/ENSPREG00000018664/ENSPREG00000001224/ENSPREG00000005794/ENSPREG00000003283/ENSPREG00000020701/ENSPREG00000003868/ENSPREG00000016489/ENSPREG00000007238/ENSPREG00000003115/ENSPREG00000013249/ENSPREG00000016307/ENSPREG00000007748/ENSPREG00000004285/ENSPREG00000018652/ENSPREG00000003639/ENSPREG00000006611/ENSPREG00000005611/ENSPREG00000004333/ENSPREG00000015114/ENSPREG00000006436/ENSPREG00000022747/ENSPREG00000020067/ENSPREG00000006682/ENSPREG00000001951/ENSPREG00000015233/ENSPREG00000005618/ENSPREG00000021106/ENSPREG00000021765/ENSPREG00000000779/ENSPREG00000010589/ENSPREG00000020380/ENSPREG00000020450/ENSPREG00000011954/ENSPREG00000012408/ENSPREG00000019635/ENSPREG00000017741/ENSPREG00000016502/ENSPREG00000013733/ENSPREG00000006914/ENSPREG00000021603/ENSPREG00000006544/ENSPREG00000002124/ENSPREG00000006678/ENSPREG00000008052/ENSPREG00000000950/ENSPREG00000001638/ENSPREG00000017444/ENSPREG00000021455/ENSPREG00000001482/ENSPREG00000010540/ENSPREG00000005421/ENSPREG00000013763/ENSPREG00000008274/ENSPREG00000013942/ENSPREG00000013074/ENSPREG00000022805/ENSPREG00000017574/ENSPREG00000011082/ENSPREG00000011132/ENSPREG00000018853/ENSPREG00000019044/ENSPREG00000017582/ENSPREG00000018413/ENSPREG00000022346/ENSPREG00000003053/ENSPREG00000003918/ENSPREG00000003789/ENSPREG00000010697/ENSPREG00000015905/ENSPREG00000017881/ENSPREG00000000593/ENSPREG00000017247/ENSPREG00000020214/ENSPREG00000002294/ENSPREG00000019665/ENSPREG00000010162/ENSPREG00000018599/ENSPREG00000018925/ENSPREG00000019676/ENSPREG00000007113/ENSPREG00000018426/ENSPREG00000010861/ENSPREG00000006420/ENSPREG00000020747/ENSPREG00000012900/ENSPREG00000002626/ENSPREG00000015822/ENSPREG00000020634/ENSPREG00000018410/ENSPREG00000005336/ENSPREG00000003791/ENSPREG00000007359/ENSPREG00000011865/ENSPREG00000022717/ENSPREG00000019594/ENSPREG00000005420/ENSPREG00000021324/ENSPREG00000005590/ENSPREG00000019957/ENSPREG00000002219/ENSPREG00000020729/ENSPREG00000019070/ENSPREG00000022577/ENSPREG00000021702/ENSPREG00000022909/ENSPREG00000019228/ENSPREG00000015809/ENSPREG00000016890/ENSPREG00000009910/ENSPREG00000021727/ENSPREG00000016174/ENSPREG00000002972/ENSPREG00000020325/ENSPREG00000003558/ENSPREG00000021213/ENSPREG00000019816/ENSPREG00000007115/ENSPREG00000004228/ENSPREG00000000181/ENSPREG00000006035/ENSPREG00000011389/ENSPREG00000020136/ENSPREG00000016562/ENSPREG00000009434/ENSPREG00000023195/ENSPREG00000016861/ENSPREG00000012846/ENSPREG00000022874/ENSPREG00000005952/ENSPREG00000021025/ENSPREG00000004576/ENSPREG00000000414/ENSPREG00000014698/ENSPREG00000020745/ENSPREG00000016294/ENSPREG00000019002/ENSPREG00000006655/ENSPREG00000006393/ENSPREG00000018452/ENSPREG00000021435/ENSPREG00000000059/ENSPREG00000019374/ENSPREG00000022590/ENSPREG00000017366/ENSPREG00000001790/ENSPREG00000015143/ENSPREG00000014141/ENSPREG00000006668/ENSPREG00000019417/ENSPREG00000020451/ENSPREG00000012167/ENSPREG00000011946/ENSPREG00000008293/ENSPREG00000021425/ENSPREG00000022224/ENSPREG00000017617/ENSPREG00000009091/ENSPREG00000000958/ENSPREG00000016663/ENSPREG00000013492/ENSPREG00000018266/ENSPREG00000005931/ENSPREG00000014503/ENSPREG00000018422/ENSPREG00000021256/ENSPREG00000011786/ENSPREG00000005086/ENSPREG00000013858/ENSPREG00000019186/ENSPREG00000018926/ENSPREG00000016295/ENSPREG00000017887/ENSPREG00000006438/ENSPREG00000013242/ENSPREG00000020456/ENSPREG00000000081/ENSPREG00000022222/ENSPREG00000009984/ENSPREG00000003979/ENSPREG00000023083/ENSPREG00000003561/ENSPREG00000006194/ENSPREG00000015626/ENSPREG00000022278/ENSPREG00000018891/ENSPREG00000000544/ENSPREG00000003003/ENSPREG00000022819/ENSPREG00000022570/ENSPREG00000004565/ENSPREG00000016136/ENSPREG00000011134/ENSPREG00000017179/ENSPREG00000005148/ENSPREG00000003987/ENSPREG00000017914/ENSPREG00000007601/ENSPREG00000011431/ENSPREG00000023244/ENSPREG00000019613/ENSPREG00000010712/ENSPREG00000016004/ENSPREG00000017448/ENSPREG00000010200/ENSPREG00000006669/ENSPREG00000012552/ENSPREG00000013262/ENSPREG00000004343/ENSPREG00000020971/ENSPREG00000015068/ENSPREG00000000817/ENSPREG00000020144/ENSPREG00000002199/ENSPREG00000009177/ENSPREG00000020784/ENSPREG00000005065/ENSPREG00000007903/ENSPREG00000017709/ENSPREG00000005185/ENSPREG00000018400/ENSPREG00000001725/ENSPREG00000022223/ENSPREG00000013653/ENSPREG00000009276/ENSPREG00000011322/ENSPREG00000011877/ENSPREG00000003965/ENSPREG00000004054/ENSPREG00000018739/ENSPREG00000002348/ENSPREG00000022836/ENSPREG00000014283/ENSPREG00000010225/ENSPREG00000016160/ENSPREG00000012500/ENSPREG00000008282/ENSPREG00000022372/ENSPREG00000016455/ENSPREG00000015764/ENSPREG00000005603/ENSPREG00000006253/ENSPREG00000018283/ENSPREG00000016542/ENSPREG00000012394/ENSPREG00000012534/ENSPREG00000023048/ENSPREG00000008155/ENSPREG00000020238/ENSPREG00000009226/ENSPREG00000021481/ENSPREG00000018360/ENSPREG00000007226/ENSPREG00000001594/ENSPREG00000020189/ENSPREG00000019101/ENSPREG00000018284/ENSPREG00000007523/ENSPREG00000014903/ENSPREG00000019086/ENSPREG00000015772/ENSPREG00000021020/ENSPREG00000010337/ENSPREG00000008825/ENSPREG00000012783/ENSPREG00000022843/ENSPREG00000016656/ENSPREG00000021224/ENSPREG00000005614/ENSPREG00000020252/ENSPREG00000002370/ENSPREG00000007974/ENSPREG00000002311/ENSPREG00000010930/ENSPREG00000008672/ENSPREG00000020167/ENSPREG00000022076/ENSPREG00000002771/ENSPREG00000002457/ENSPREG00000014625/ENSPREG00000009816/ENSPREG00000007713/ENSPREG00000014570/ENSPREG00000015652/ENSPREG00000002292/ENSPREG00000017550/ENSPREG00000001752/ENSPREG00000020768/ENSPREG00000006738/ENSPREG00000001563/ENSPREG00000019089/ENSPREG00000013300/ENSPREG00000011930/ENSPREG00000007324/ENSPREG00000014793/ENSPREG00000009793/ENSPREG00000018286/ENSPREG00000004067/ENSPREG00000010201/ENSPREG00000021218/ENSPREG00000022921/ENSPREG00000016483/ENSPREG00000017605/ENSPREG00000001336/ENSPREG00000018689/ENSPREG00000003692/ENSPREG00000020801/ENSPREG00000018552/ENSPREG00000017873/ENSPREG00000001741/ENSPREG00000022183/ENSPREG00000008213/ENSPREG00000002702/ENSPREG00000001939/ENSPREG00000008843/ENSPREG00000010997/ENSPREG00000012330/ENSPREG00000004374/ENSPREG00000010863/ENSPREG00000010771/ENSPREG00000022527/ENSPREG00000018757/ENSPREG00000014183/ENSPREG00000007319/ENSPREG00000008228/ENSPREG00000014668/ENSPREG00000017111/ENSPREG00000010516/ENSPREG00000022428/ENSPREG00000016577/ENSPREG00000010544/ENSPREG00000007496/ENSPREG00000021395/ENSPREG00000019656/ENSPREG00000022918/ENSPREG00000003604/ENSPREG00000005687/ENSPREG00000021439/ENSPREG00000021750/ENSPREG00000010047/ENSPREG00000018719/ENSPREG00000009526/ENSPREG00000021744/ENSPREG00000019860/ENSPREG00000008668/ENSPREG00000011196/ENSPREG00000019165/ENSPREG00000023240/ENSPREG00000009737/ENSPREG00000005820/ENSPREG00000016961/ENSPREG00000013496/ENSPREG00000016138/ENSPREG00000002905/ENSPREG00000004060/ENSPREG00000004632/ENSPREG00000015216/ENSPREG00000021179/ENSPREG00000003815/ENSPREG00000010951/ENSPREG00000002185/ENSPREG00000021321/ENSPREG00000000207/ENSPREG00000010817/ENSPREG00000011250/ENSPREG00000006378/ENSPREG00000008623/ENSPREG00000011108/ENSPREG00000001610/ENSPREG00000017365/ENSPREG00000021629/ENSPREG00000008027/ENSPREG00000020125/ENSPREG00000002598/ENSPREG00000014968/ENSPREG00000022018/ENSPREG00000002758/ENSPREG00000010975/ENSPREG00000017042/ENSPREG00000020542/ENSPREG00000005920/ENSPREG00000018229/ENSPREG00000019248/ENSPREG00000015541/ENSPREG00000022877/ENSPREG00000017095/ENSPREG00000008883/ENSPREG00000013631/ENSPREG00000020815/ENSPREG00000010793/ENSPREG00000020669/ENSPREG00000004391/ENSPREG00000002967/ENSPREG00000005457/ENSPREG00000015354/ENSPREG00000015192/ENSPREG00000002278/ENSPREG00000005450/ENSPREG00000012757/ENSPREG00000010745/ENSPREG00000000552/ENSPREG00000000614/ENSPREG00000008118/ENSPREG00000004233/ENSPREG00000000631/ENSPREG00000000664/ENSPREG00000017335/ENSPREG00000016007/ENSPREG00000015635/ENSPREG00000015338/ENSPREG00000018217/ENSPREG00000012544/ENSPREG00000021825/ENSPREG00000014040/ENSPREG00000023051/ENSPREG00000015389/ENSPREG00000012225/ENSPREG00000012158/ENSPREG00000013793/ENSPREG00000006529/ENSPREG00000013710/ENSPREG00000012958/ENSPREG00000003820/ENSPREG00000013129/ENSPREG00000002655/ENSPREG00000020433/ENSPREG00000019331/ENSPREG00000018661/ENSPREG00000007988/ENSPREG00000021217/ENSPREG00000005412/ENSPREG00000002047/ENSPREG00000018579/ENSPREG00000001094/ENSPREG00000004127/ENSPREG00000006550/ENSPREG00000012463/ENSPREG00000004302/ENSPREG00000009287/ENSPREG00000015411/ENSPREG00000009568/ENSPREG00000020231/ENSPREG00000010237/ENSPREG00000002204/ENSPREG00000007053/ENSPREG00000014117/ENSPREG00000014293/ENSPREG00000008917/ENSPREG00000016312/ENSPREG00000006981/ENSPREG00000008019/ENSPREG00000017396/ENSPREG00000003680/ENSPREG00000020583/ENSPREG00000002932/ENSPREG00000022000/ENSPREG00000008770/ENSPREG00000020152/ENSPREG00000021013/ENSPREG00000017431/ENSPREG00000015390/ENSPREG00000019122/ENSPREG00000005008/ENSPREG00000007168/ENSPREG00000017326/ENSPREG00000004666/ENSPREG00000002137/ENSPREG00000020279/ENSPREG00000005591/ENSPREG00000013171/ENSPREG00000000480/ENSPREG00000020803/ENSPREG00000012665/ENSPREG00000003037/ENSPREG00000017058/ENSPREG00000006578/ENSPREG00000015791/ENSPREG00000001070/ENSPREG00000013800/ENSPREG00000004172/ENSPREG00000006781/ENSPREG00000000452/ENSPREG00000007785/ENSPREG00000000528/ENSPREG00000010535/ENSPREG00000008848/ENSPREG00000022434/ENSPREG00000020590/ENSPREG00000014636/ENSPREG00000012373/ENSPREG00000003236/ENSPREG00000012273/ENSPREG00000018193/ENSPREG00000012401/ENSPREG00000017054/ENSPREG00000008187/ENSPREG00000009677/ENSPREG00000009497/ENSPREG00000002257/ENSPREG00000013980/ENSPREG00000010157/ENSPREG00000009366/ENSPREG00000005211/ENSPREG00000022741/ENSPREG00000018227/ENSPREG00000014532/ENSPREG00000019115/ENSPREG00000023140/ENSPREG00000008410/ENSPREG00000011957/ENSPREG00000009338/ENSPREG00000010850/ENSPREG00000009142/ENSPREG00000002898/ENSPREG00000014206/ENSPREG00000008157/ENSPREG00000005626/ENSPREG00000012024/ENSPREG00000020099/ENSPREG00000015823/ENSPREG00000004259/ENSPREG00000018641/ENSPREG00000010853/ENSPREG00000007682/ENSPREG00000013562/ENSPREG00000000485/ENSPREG00000012569/ENSPREG00000015203/ENSPREG00000000794/ENSPREG00000003169/ENSPREG00000008034/ENSPREG00000010979/ENSPREG00000014824/ENSPREG00000007689/ENSPREG00000016036/ENSPREG00000006583/ENSPREG00000010595/ENSPREG00000012696/ENSPREG00000015391/ENSPREG00000010973/ENSPREG00000008355/ENSPREG00000001918/ENSPREG00000022447/ENSPREG00000014490/ENSPREG00000001407/ENSPREG00000016063/ENSPREG00000020789/ENSPREG00000004395/ENSPREG00000020563/ENSPREG00000002175/ENSPREG00000007271/ENSPREG00000017893/ENSPREG00000011365/ENSPREG00000010886/ENSPREG00000022828/ENSPREG00000014338/ENSPREG00000018900/ENSPREG00000010345/ENSPREG00000000609/ENSPREG00000002053/ENSPREG00000011081/ENSPREG00000019038/ENSPREG00000000688/ENSPREG00000003630/ENSPREG00000022336/ENSPREG00000009089/ENSPREG00000020673/ENSPREG00000002203/ENSPREG00000011959/ENSPREG00000010772/ENSPREG00000018698/ENSPREG00000004325/ENSPREG00000000598/ENSPREG00000004080/ENSPREG00000010346/ENSPREG00000002929
## GO:0005634 nucleus                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                       ENSPREG00000022956/ENSPREG00000011953/ENSPREG00000019319/ENSPREG00000020203/ENSPREG00000012188/ENSPREG00000015471/ENSPREG00000019823/ENSPREG00000011367/ENSPREG00000000100/ENSPREG00000001369/ENSPREG00000016198/ENSPREG00000004628/ENSPREG00000006929/ENSPREG00000005331/ENSPREG00000011568/ENSPREG00000003428/ENSPREG00000018820/ENSPREG00000007900/ENSPREG00000011918/ENSPREG00000021152/ENSPREG00000014413/ENSPREG00000021725/ENSPREG00000020093/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000003088/ENSPREG00000006767/ENSPREG00000002287/ENSPREG00000012582/ENSPREG00000020193/ENSPREG00000001808/ENSPREG00000006315/ENSPREG00000000922/ENSPREG00000005246/ENSPREG00000013067/ENSPREG00000022267/ENSPREG00000009351/ENSPREG00000016347/ENSPREG00000004107/ENSPREG00000001734/ENSPREG00000018881/ENSPREG00000006464/ENSPREG00000000568/ENSPREG00000002117/ENSPREG00000014973/ENSPREG00000009674/ENSPREG00000008235/ENSPREG00000019479/ENSPREG00000012868/ENSPREG00000002795/ENSPREG00000021689/ENSPREG00000022924/ENSPREG00000011913/ENSPREG00000000298/ENSPREG00000022703/ENSPREG00000004976/ENSPREG00000019795/ENSPREG00000000313/ENSPREG00000004425/ENSPREG00000021707/ENSPREG00000013048/ENSPREG00000019472/ENSPREG00000000639/ENSPREG00000010086/ENSPREG00000018023/ENSPREG00000018972/ENSPREG00000007715/ENSPREG00000021553/ENSPREG00000016979/ENSPREG00000003658/ENSPREG00000022723/ENSPREG00000014608/ENSPREG00000004390/ENSPREG00000001387/ENSPREG00000011064/ENSPREG00000001742/ENSPREG00000018730/ENSPREG00000004023/ENSPREG00000006460/ENSPREG00000000443/ENSPREG00000012137/ENSPREG00000005042/ENSPREG00000003440/ENSPREG00000021865/ENSPREG00000004029/ENSPREG00000005028/ENSPREG00000016797/ENSPREG00000010250/ENSPREG00000019031/ENSPREG00000013386/ENSPREG00000017016/ENSPREG00000021088/ENSPREG00000007722/ENSPREG00000013766/ENSPREG00000015491/ENSPREG00000005599/ENSPREG00000008667/ENSPREG00000008815/ENSPREG00000011689/ENSPREG00000020701/ENSPREG00000012325/ENSPREG00000013423/ENSPREG00000021691/ENSPREG00000017021/ENSPREG00000015810/ENSPREG00000016307/ENSPREG00000011212/ENSPREG00000013528/ENSPREG00000012105/ENSPREG00000008389/ENSPREG00000007498/ENSPREG00000016112/ENSPREG00000006945/ENSPREG00000016676/ENSPREG00000022466/ENSPREG00000007342/ENSPREG00000009326/ENSPREG00000000793/ENSPREG00000010244/ENSPREG00000021231/ENSPREG00000022114/ENSPREG00000018272/ENSPREG00000011441/ENSPREG00000014875/ENSPREG00000013058/ENSPREG00000005993/ENSPREG00000019635/ENSPREG00000004345/ENSPREG00000006032/ENSPREG00000006079/ENSPREG00000006544/ENSPREG00000010644/ENSPREG00000008377/ENSPREG00000005482/ENSPREG00000000447/ENSPREG00000016792/ENSPREG00000008274/ENSPREG00000006489/ENSPREG00000017440/ENSPREG00000011620/ENSPREG00000002617/ENSPREG00000017582/ENSPREG00000003918/ENSPREG00000015905/ENSPREG00000000593/ENSPREG00000017247/ENSPREG00000011942/ENSPREG00000018564/ENSPREG00000010162/ENSPREG00000013784/ENSPREG00000018925/ENSPREG00000019566/ENSPREG00000008418/ENSPREG00000008711/ENSPREG00000016256/ENSPREG00000022772/ENSPREG00000010684/ENSPREG00000018166/ENSPREG00000018464/ENSPREG00000023206/ENSPREG00000003325/ENSPREG00000020685/ENSPREG00000012541/ENSPREG00000022711/ENSPREG00000023148/ENSPREG00000010768/ENSPREG00000012184/ENSPREG00000011231/ENSPREG00000000290/ENSPREG00000021702/ENSPREG00000015809/ENSPREG00000006880/ENSPREG00000008156/ENSPREG00000015548/ENSPREG00000022552/ENSPREG00000017649/ENSPREG00000015738/ENSPREG00000016534/ENSPREG00000001635/ENSPREG00000015654/ENSPREG00000000386/ENSPREG00000021907/ENSPREG00000022194/ENSPREG00000000414/ENSPREG00000016146/ENSPREG00000003063/ENSPREG00000013804/ENSPREG00000007429/ENSPREG00000022340/ENSPREG00000007244/ENSPREG00000012296/ENSPREG00000014911/ENSPREG00000011868/ENSPREG00000009925/ENSPREG00000009117/ENSPREG00000009024/ENSPREG00000000763/ENSPREG00000013492/ENSPREG00000018266/ENSPREG00000007061/ENSPREG00000004422/ENSPREG00000013858/ENSPREG00000015499/ENSPREG00000015766/ENSPREG00000010135/ENSPREG00000017887/ENSPREG00000014453/ENSPREG00000020764/ENSPREG00000006276/ENSPREG00000002822/ENSPREG00000022206/ENSPREG00000009984/ENSPREG00000013353/ENSPREG00000021982/ENSPREG00000003561/ENSPREG00000015626/ENSPREG00000000378/ENSPREG00000004142/ENSPREG00000022365/ENSPREG00000009357/ENSPREG00000015451/ENSPREG00000013384/ENSPREG00000003987/ENSPREG00000008032/ENSPREG00000004549/ENSPREG00000009008/ENSPREG00000001155/ENSPREG00000023244/ENSPREG00000017352/ENSPREG00000013812/ENSPREG00000015468/ENSPREG00000019200/ENSPREG00000011115/ENSPREG00000014063/ENSPREG00000005130/ENSPREG00000017403/ENSPREG00000022452/ENSPREG00000016470/ENSPREG00000009177/ENSPREG00000020206/ENSPREG00000022223/ENSPREG00000022308/ENSPREG00000003495/ENSPREG00000020471/ENSPREG00000022066/ENSPREG00000000461/ENSPREG00000011877/ENSPREG00000022836/ENSPREG00000004581/ENSPREG00000020157/ENSPREG00000000184/ENSPREG00000008282/ENSPREG00000003434/ENSPREG00000019531/ENSPREG00000021498/ENSPREG00000004768/ENSPREG00000004398/ENSPREG00000010196/ENSPREG00000019774/ENSPREG00000023216/ENSPREG00000018276/ENSPREG00000005380/ENSPREG00000012965/ENSPREG00000002259/ENSPREG00000006758/ENSPREG00000006371/ENSPREG00000021952/ENSPREG00000005932/ENSPREG00000012916/ENSPREG00000018299/ENSPREG00000020189/ENSPREG00000019101/ENSPREG00000005566/ENSPREG00000009731/ENSPREG00000001226/ENSPREG00000016716/ENSPREG00000014803/ENSPREG00000014120/ENSPREG00000015465/ENSPREG00000021052/ENSPREG00000018746/ENSPREG00000016803/ENSPREG00000005385/ENSPREG00000016821/ENSPREG00000015137/ENSPREG00000014657/ENSPREG00000009131/ENSPREG00000011930/ENSPREG00000020291/ENSPREG00000009793/ENSPREG00000010143/ENSPREG00000002926/ENSPREG00000008906/ENSPREG00000008997/ENSPREG00000017605/ENSPREG00000006998/ENSPREG00000021362/ENSPREG00000002753/ENSPREG00000012420/ENSPREG00000008972/ENSPREG00000010182/ENSPREG00000021486/ENSPREG00000020466/ENSPREG00000005945/ENSPREG00000015409/ENSPREG00000008106/ENSPREG00000010863/ENSPREG00000000847/ENSPREG00000008918/ENSPREG00000011687/ENSPREG00000022501/ENSPREG00000022696/ENSPREG00000007149/ENSPREG00000015111/ENSPREG00000007940/ENSPREG00000005157/ENSPREG00000008456/ENSPREG00000008761/ENSPREG00000018719/ENSPREG00000018558/ENSPREG00000020464/ENSPREG00000005278/ENSPREG00000006455/ENSPREG00000011196/ENSPREG00000011189/ENSPREG00000017548/ENSPREG00000016517/ENSPREG00000006631/ENSPREG00000001171/ENSPREG00000004807/ENSPREG00000007784/ENSPREG00000003764/ENSPREG00000018793/ENSPREG00000015189/ENSPREG00000012574/ENSPREG00000001610/ENSPREG00000017365/ENSPREG00000008027/ENSPREG00000014784/ENSPREG00000009250/ENSPREG00000000644/ENSPREG00000017666/ENSPREG00000000311/ENSPREG00000016107/ENSPREG00000000434/ENSPREG00000001334/ENSPREG00000018229/ENSPREG00000007173/ENSPREG00000013706/ENSPREG00000008934/ENSPREG00000004357/ENSPREG00000006179/ENSPREG00000010793/ENSPREG00000015981/ENSPREG00000019517/ENSPREG00000006395/ENSPREG00000015043/ENSPREG00000009968/ENSPREG00000011732/ENSPREG00000005552/ENSPREG00000007743/ENSPREG00000021574/ENSPREG00000006372/ENSPREG00000010735/ENSPREG00000004431/ENSPREG00000022407/ENSPREG00000010381/ENSPREG00000018009/ENSPREG00000002047/ENSPREG00000002070/ENSPREG00000015589/ENSPREG00000004545/ENSPREG00000013196/ENSPREG00000011076/ENSPREG00000003192/ENSPREG00000008796/ENSPREG00000010818/ENSPREG00000014115/ENSPREG00000003680/ENSPREG00000016863/ENSPREG00000010451/ENSPREG00000022630/ENSPREG00000019131/ENSPREG00000005038/ENSPREG00000009155/ENSPREG00000005008/ENSPREG00000006819/ENSPREG00000013848/ENSPREG00000013881/ENSPREG00000017058/ENSPREG00000013800/ENSPREG00000000452/ENSPREG00000012578/ENSPREG00000018769/ENSPREG00000006806/ENSPREG00000000741/ENSPREG00000005138/ENSPREG00000011546/ENSPREG00000015736/ENSPREG00000016371/ENSPREG00000015450/ENSPREG00000018193/ENSPREG00000012357/ENSPREG00000018976/ENSPREG00000001380/ENSPREG00000009850/ENSPREG00000019837/ENSPREG00000001459/ENSPREG00000022088/ENSPREG00000017572/ENSPREG00000022410/ENSPREG00000005401/ENSPREG00000018873/ENSPREG00000021337/ENSPREG00000019455/ENSPREG00000009744/ENSPREG00000015203/ENSPREG00000006068/ENSPREG00000000147/ENSPREG00000019962/ENSPREG00000020174/ENSPREG00000013887/ENSPREG00000010102/ENSPREG00000000133/ENSPREG00000001918/ENSPREG00000020443/ENSPREG00000011131/ENSPREG00000019762/ENSPREG00000016063/ENSPREG00000012631/ENSPREG00000011387/ENSPREG00000020789/ENSPREG00000011871/ENSPREG00000005818/ENSPREG00000021516/ENSPREG00000009681/ENSPREG00000018056/ENSPREG00000001047/ENSPREG00000021969/ENSPREG00000007068/ENSPREG00000010174/ENSPREG00000001848/ENSPREG00000005824/ENSPREG00000006796/ENSPREG00000003295/ENSPREG00000009834/ENSPREG00000006388/ENSPREG00000002487/ENSPREG00000018513/ENSPREG00000012719/ENSPREG00000018198/ENSPREG00000018453/ENSPREG00000017721/ENSPREG00000010475/ENSPREG00000010598/ENSPREG00000011959/ENSPREG00000004232
## GO:0007154 cell communication                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000020653/ENSPREG00000001141/ENSPREG00000022383/ENSPREG00000019494/ENSPREG00000017358/ENSPREG00000001183/ENSPREG00000012113/ENSPREG00000021249/ENSPREG00000011792/ENSPREG00000020520/ENSPREG00000008751/ENSPREG00000012421/ENSPREG00000004840/ENSPREG00000021525/ENSPREG00000017316/ENSPREG00000004990/ENSPREG00000002598/ENSPREG00000006256/ENSPREG00000000914/ENSPREG00000001496/ENSPREG00000019124
## GO:0032264 IMP salvage                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                            ENSPREG00000022253/ENSPREG00000015439/ENSPREG00000003612/ENSPREG00000023054/ENSPREG00000004091/ENSPREG00000011534
## GO:0003690 double-stranded DNA binding                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                      ENSPREG00000003088/ENSPREG00000017119/ENSPREG00000015766/ENSPREG00000000378/ENSPREG00000019200/ENSPREG00000021052/ENSPREG00000019537/ENSPREG00000020992
## GO:0006166 purine ribonucleoside salvage                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                             ENSPREG00000022253/ENSPREG00000015439/ENSPREG00000003612/ENSPREG00000023054/ENSPREG00000021913
## GO:0032012 regulation of ARF protein signal transduction                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                              ENSPREG00000002608/ENSPREG00000003508/ENSPREG00000006506/ENSPREG00000020209/ENSPREG00000020133/ENSPREG00000012759/ENSPREG00000004233/ENSPREG00000003858/ENSPREG00000003037/ENSPREG00000018759
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                               ENSPREG00000001369/ENSPREG00000009674/ENSPREG00000022546/ENSPREG00000013985/ENSPREG00000020978/ENSPREG00000008940
## GO:0072015 glomerular visceral epithelial cell development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                  ENSPREG00000010086/ENSPREG00000012932/ENSPREG00000013106/ENSPREG00000019988/ENSPREG00000012296/ENSPREG00000018284/ENSPREG00000000675/ENSPREG00000008063
## GO:0005244 voltage-gated ion channel activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000023124/ENSPREG00000020645/ENSPREG00000000841/ENSPREG00000019952/ENSPREG00000001983/ENSPREG00000005051/ENSPREG00000008683/ENSPREG00000004407/ENSPREG00000009454/ENSPREG00000016489/ENSPREG00000006682/ENSPREG00000016414/ENSPREG00000004538/ENSPREG00000016824/ENSPREG00000010074/ENSPREG00000015145/ENSPREG00000018495/ENSPREG00000004085/ENSPREG00000017980/ENSPREG00000021042/ENSPREG00000002771/ENSPREG00000008213/ENSPREG00000007555/ENSPREG00000008714/ENSPREG00000013496/ENSPREG00000000384/ENSPREG00000003070/ENSPREG00000022122/ENSPREG00000013671/ENSPREG00000009258/ENSPREG00000009142/ENSPREG00000008157/ENSPREG00000006583/ENSPREG00000006609/ENSPREG00000011081/ENSPREG00000007547
## GO:0034765 regulation of ion transmembrane transport                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                    ENSPREG00000023124/ENSPREG00000020645/ENSPREG00000000841/ENSPREG00000019952/ENSPREG00000001983/ENSPREG00000005051/ENSPREG00000008683/ENSPREG00000004407/ENSPREG00000009454/ENSPREG00000016489/ENSPREG00000006682/ENSPREG00000016414/ENSPREG00000004538/ENSPREG00000016824/ENSPREG00000010074/ENSPREG00000015145/ENSPREG00000018495/ENSPREG00000004085/ENSPREG00000017980/ENSPREG00000021042/ENSPREG00000002771/ENSPREG00000008213/ENSPREG00000007555/ENSPREG00000008714/ENSPREG00000013496/ENSPREG00000000384/ENSPREG00000003070/ENSPREG00000022122/ENSPREG00000013671/ENSPREG00000009258/ENSPREG00000009142/ENSPREG00000008157/ENSPREG00000006583/ENSPREG00000006609/ENSPREG00000011081/ENSPREG00000007547
## GO:0003677 DNA binding                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000022956/ENSPREG00000020203/ENSPREG00000012188/ENSPREG00000004595/ENSPREG00000011367/ENSPREG00000001369/ENSPREG00000016198/ENSPREG00000004628/ENSPREG00000006929/ENSPREG00000003428/ENSPREG00000018820/ENSPREG00000010940/ENSPREG00000007900/ENSPREG00000011918/ENSPREG00000014413/ENSPREG00000021725/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000003088/ENSPREG00000006767/ENSPREG00000012582/ENSPREG00000020394/ENSPREG00000006315/ENSPREG00000000922/ENSPREG00000013067/ENSPREG00000022267/ENSPREG00000009351/ENSPREG00000004107/ENSPREG00000018881/ENSPREG00000000568/ENSPREG00000002117/ENSPREG00000009674/ENSPREG00000014960/ENSPREG00000019479/ENSPREG00000002795/ENSPREG00000022924/ENSPREG00000011913/ENSPREG00000019795/ENSPREG00000004425/ENSPREG00000012831/ENSPREG00000013048/ENSPREG00000011292/ENSPREG00000018023/ENSPREG00000007715/ENSPREG00000021553/ENSPREG00000022723/ENSPREG00000011064/ENSPREG00000007733/ENSPREG00000004023/ENSPREG00000010341/ENSPREG00000011157/ENSPREG00000006460/ENSPREG00000004029/ENSPREG00000016797/ENSPREG00000015341/ENSPREG00000010250/ENSPREG00000013386/ENSPREG00000017016/ENSPREG00000001592/ENSPREG00000013766/ENSPREG00000015491/ENSPREG00000004266/ENSPREG00000008667/ENSPREG00000008815/ENSPREG00000002849/ENSPREG00000020701/ENSPREG00000012325/ENSPREG00000021691/ENSPREG00000015810/ENSPREG00000011212/ENSPREG00000012105/ENSPREG00000017347/ENSPREG00000007498/ENSPREG00000006945/ENSPREG00000016676/ENSPREG00000007342/ENSPREG00000009326/ENSPREG00000011441/ENSPREG00000019519/ENSPREG00000013058/ENSPREG00000005993/ENSPREG00000012718/ENSPREG00000008377/ENSPREG00000021474/ENSPREG00000006489/ENSPREG00000017440/ENSPREG00000011620/ENSPREG00000017582/ENSPREG00000015905/ENSPREG00000017247/ENSPREG00000011942/ENSPREG00000019566/ENSPREG00000008418/ENSPREG00000016256/ENSPREG00000022772/ENSPREG00000023206/ENSPREG00000003325/ENSPREG00000012541/ENSPREG00000023148/ENSPREG00000012184/ENSPREG00000011231/ENSPREG00000000290/ENSPREG00000003558/ENSPREG00000013985/ENSPREG00000017649/ENSPREG00000015738/ENSPREG00000015654/ENSPREG00000022194/ENSPREG00000000414/ENSPREG00000016146/ENSPREG00000003063/ENSPREG00000013804/ENSPREG00000015395/ENSPREG00000022340/ENSPREG00000009925/ENSPREG00000006077/ENSPREG00000020249/ENSPREG00000016663/ENSPREG00000013492/ENSPREG00000007061/ENSPREG00000015499/ENSPREG00000014453/ENSPREG00000006276/ENSPREG00000002822/ENSPREG00000013353/ENSPREG00000020281/ENSPREG00000013213/ENSPREG00000023244/ENSPREG00000013812/ENSPREG00000015468/ENSPREG00000019200/ENSPREG00000011115/ENSPREG00000005130/ENSPREG00000020206/ENSPREG00000010210/ENSPREG00000022066/ENSPREG00000009279/ENSPREG00000004581/ENSPREG00000019531/ENSPREG00000004768/ENSPREG00000010196/ENSPREG00000019774/ENSPREG00000005380/ENSPREG00000012965/ENSPREG00000002259/ENSPREG00000006758/ENSPREG00000009056/ENSPREG00000018299/ENSPREG00000019101/ENSPREG00000009731/ENSPREG00000001226/ENSPREG00000016716/ENSPREG00000014803/ENSPREG00000014120/ENSPREG00000015465/ENSPREG00000021052/ENSPREG00000018746/ENSPREG00000005385/ENSPREG00000016821/ENSPREG00000014657/ENSPREG00000009131/ENSPREG00000011496/ENSPREG00000008402/ENSPREG00000002926/ENSPREG00000006998/ENSPREG00000015289/ENSPREG00000013765/ENSPREG00000012420/ENSPREG00000019537/ENSPREG00000021486/ENSPREG00000020466/ENSPREG00000015409/ENSPREG00000008106/ENSPREG00000010863/ENSPREG00000000847/ENSPREG00000008918/ENSPREG00000022501/ENSPREG00000008761/ENSPREG00000018558/ENSPREG00000000792/ENSPREG00000012765/ENSPREG00000006455/ENSPREG00000004845/ENSPREG00000017548/ENSPREG00000008940/ENSPREG00000006631/ENSPREG00000002181/ENSPREG00000015189/ENSPREG00000017365/ENSPREG00000014784/ENSPREG00000009250/ENSPREG00000000644/ENSPREG00000017666/ENSPREG00000000434/ENSPREG00000001334/ENSPREG00000009851/ENSPREG00000006179/ENSPREG00000015043/ENSPREG00000022402/ENSPREG00000011732/ENSPREG00000014207/ENSPREG00000000939/ENSPREG00000013196/ENSPREG00000014115/ENSPREG00000003680/ENSPREG00000008368/ENSPREG00000016863/ENSPREG00000010451/ENSPREG00000022630/ENSPREG00000005038/ENSPREG00000009155/ENSPREG00000006819/ENSPREG00000013623/ENSPREG00000022317/ENSPREG00000009052/ENSPREG00000000949/ENSPREG00000006806/ENSPREG00000008423/ENSPREG00000011546/ENSPREG00000016371/ENSPREG00000018249/ENSPREG00000015450/ENSPREG00000018193/ENSPREG00000018976/ENSPREG00000003016/ENSPREG00000001380/ENSPREG00000009850/ENSPREG00000022088/ENSPREG00000022410/ENSPREG00000018873/ENSPREG00000021337/ENSPREG00000019962/ENSPREG00000017740/ENSPREG00000010102/ENSPREG00000011131/ENSPREG00000019762/ENSPREG00000011387/ENSPREG00000011871/ENSPREG00000009681/ENSPREG00000010174/ENSPREG00000006796/ENSPREG00000009834/ENSPREG00000006388/ENSPREG00000002487/ENSPREG00000012707/ENSPREG00000018453/ENSPREG00000017721/ENSPREG00000011400/ENSPREG00000006239/ENSPREG00000004232
##                                                                                     Count
## GO:0007275 multicellular organism development                                         134
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific       73
## GO:0006355 regulation of transcription, DNA-templated                                 207
## GO:0005515 protein binding                                                            720
## GO:0005634 nucleus                                                                    457
## GO:0007154 cell communication                                                          21
## GO:0032264 IMP salvage                                                                  6
## GO:0003690 double-stranded DNA binding                                                  8
## GO:0006166 purine ribonucleoside salvage                                                5
## GO:0032012 regulation of ARF protein signal transduction                               10
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific     6
## GO:0072015 glomerular visceral epithelial cell development                              8
## GO:0005244 voltage-gated ion channel activity                                          36
## GO:0034765 regulation of ion transmembrane transport                                   36
## GO:0003677 DNA binding                                                                250
c_dn <- enricher(gene = GvL_dn, universe = GvL_bg, minGSSize = 5,  maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_dn,15)
##                                                                                                                                                                ID
## GO:0005096 GTPase activator activity                                                                                         GO:0005096 GTPase activator activity
## GO:0043547 positive regulation of GTPase activity                                                               GO:0043547 positive regulation of GTPase activity
## GO:0061053 somite development                                                                                                       GO:0061053 somite development
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0030027 lamellipodium                                                                                                                 GO:0030027 lamellipodium
## GO:0008543 fibroblast growth factor receptor signaling pathway                                     GO:0008543 fibroblast growth factor receptor signaling pathway
## GO:0043087 regulation of GTPase activity                                                                                 GO:0043087 regulation of GTPase activity
## GO:0042074 cell migration involved in gastrulation                                                             GO:0042074 cell migration involved in gastrulation
## GO:0002574 thrombocyte differentiation                                                                                     GO:0002574 thrombocyte differentiation
## GO:0006357 regulation of transcription by RNA polymerase II                                           GO:0006357 regulation of transcription by RNA polymerase II
## GO:0006940 regulation of smooth muscle contraction                                                             GO:0006940 regulation of smooth muscle contraction
## GO:0035198 miRNA binding                                                                                                                 GO:0035198 miRNA binding
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                       GO:0035479 angioblast cell migration from lateral mesoderm to midline
## GO:0046580 negative regulation of Ras protein signal transduction                               GO:0046580 negative regulation of Ras protein signal transduction
## GO:0007266 Rho protein signal transduction                                                                             GO:0007266 Rho protein signal transduction
##                                                                                                                                                       Description
## GO:0005096 GTPase activator activity                                                                                         GO:0005096 GTPase activator activity
## GO:0043547 positive regulation of GTPase activity                                                               GO:0043547 positive regulation of GTPase activity
## GO:0061053 somite development                                                                                                       GO:0061053 somite development
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0030027 lamellipodium                                                                                                                 GO:0030027 lamellipodium
## GO:0008543 fibroblast growth factor receptor signaling pathway                                     GO:0008543 fibroblast growth factor receptor signaling pathway
## GO:0043087 regulation of GTPase activity                                                                                 GO:0043087 regulation of GTPase activity
## GO:0042074 cell migration involved in gastrulation                                                             GO:0042074 cell migration involved in gastrulation
## GO:0002574 thrombocyte differentiation                                                                                     GO:0002574 thrombocyte differentiation
## GO:0006357 regulation of transcription by RNA polymerase II                                           GO:0006357 regulation of transcription by RNA polymerase II
## GO:0006940 regulation of smooth muscle contraction                                                             GO:0006940 regulation of smooth muscle contraction
## GO:0035198 miRNA binding                                                                                                                 GO:0035198 miRNA binding
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                       GO:0035479 angioblast cell migration from lateral mesoderm to midline
## GO:0046580 negative regulation of Ras protein signal transduction                               GO:0046580 negative regulation of Ras protein signal transduction
## GO:0007266 Rho protein signal transduction                                                                             GO:0007266 Rho protein signal transduction
##                                                                                  GeneRatio
## GO:0005096 GTPase activator activity                                               39/2621
## GO:0043547 positive regulation of GTPase activity                                  38/2621
## GO:0061053 somite development                                                      10/2621
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific   56/2621
## GO:0030027 lamellipodium                                                           14/2621
## GO:0008543 fibroblast growth factor receptor signaling pathway                     11/2621
## GO:0043087 regulation of GTPase activity                                           10/2621
## GO:0042074 cell migration involved in gastrulation                                 13/2621
## GO:0002574 thrombocyte differentiation                                              5/2621
## GO:0006357 regulation of transcription by RNA polymerase II                        72/2621
## GO:0006940 regulation of smooth muscle contraction                                  4/2621
## GO:0035198 miRNA binding                                                            4/2621
## GO:0035479 angioblast cell migration from lateral mesoderm to midline               4/2621
## GO:0046580 negative regulation of Ras protein signal transduction                   4/2621
## GO:0007266 Rho protein signal transduction                                          6/2621
##                                                                                    BgRatio
## GO:0005096 GTPase activator activity                                             146/18091
## GO:0043547 positive regulation of GTPase activity                                149/18091
## GO:0061053 somite development                                                     24/18091
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 260/18091
## GO:0030027 lamellipodium                                                          42/18091
## GO:0008543 fibroblast growth factor receptor signaling pathway                    30/18091
## GO:0043087 regulation of GTPase activity                                          27/18091
## GO:0042074 cell migration involved in gastrulation                                41/18091
## GO:0002574 thrombocyte differentiation                                             9/18091
## GO:0006357 regulation of transcription by RNA polymerase II                      370/18091
## GO:0006940 regulation of smooth muscle contraction                                 6/18091
## GO:0035198 miRNA binding                                                           6/18091
## GO:0035479 angioblast cell migration from lateral mesoderm to midline              6/18091
## GO:0046580 negative regulation of Ras protein signal transduction                  6/18091
## GO:0007266 Rho protein signal transduction                                        13/18091
##                                                                                        pvalue
## GO:0005096 GTPase activator activity                                             7.950108e-05
## GO:0043547 positive regulation of GTPase activity                                2.741006e-04
## GO:0061053 somite development                                                    1.117922e-03
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 1.291365e-03
## GO:0030027 lamellipodium                                                         1.681643e-03
## GO:0008543 fibroblast growth factor receptor signaling pathway                   2.199833e-03
## GO:0043087 regulation of GTPase activity                                         3.183034e-03
## GO:0042074 cell migration involved in gastrulation                               3.994801e-03
## GO:0002574 thrombocyte differentiation                                           4.811215e-03
## GO:0006357 regulation of transcription by RNA polymerase II                      4.928195e-03
## GO:0006940 regulation of smooth muscle contraction                               5.160769e-03
## GO:0035198 miRNA binding                                                         5.160769e-03
## GO:0035479 angioblast cell migration from lateral mesoderm to midline            5.160769e-03
## GO:0046580 negative regulation of Ras protein signal transduction                5.160769e-03
## GO:0007266 Rho protein signal transduction                                       6.310493e-03
##                                                                                   p.adjust
## GO:0005096 GTPase activator activity                                             0.1182181
## GO:0043547 positive regulation of GTPase activity                                0.2037938
## GO:0061053 somite development                                                    0.4800650
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.4800650
## GO:0030027 lamellipodium                                                         0.5001207
## GO:0008543 fibroblast growth factor receptor signaling pathway                   0.5451919
## GO:0043087 regulation of GTPase activity                                         0.5481474
## GO:0042074 cell migration involved in gastrulation                               0.5481474
## GO:0002574 thrombocyte differentiation                                           0.5481474
## GO:0006357 regulation of transcription by RNA polymerase II                      0.5481474
## GO:0006940 regulation of smooth muscle contraction                               0.5481474
## GO:0035198 miRNA binding                                                         0.5481474
## GO:0035479 angioblast cell migration from lateral mesoderm to midline            0.5481474
## GO:0046580 negative regulation of Ras protein signal transduction                0.5481474
## GO:0007266 Rho protein signal transduction                                       0.5947356
##                                                                                     qvalue
## GO:0005096 GTPase activator activity                                             0.1182181
## GO:0043547 positive regulation of GTPase activity                                0.2037938
## GO:0061053 somite development                                                    0.4800650
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.4800650
## GO:0030027 lamellipodium                                                         0.5001207
## GO:0008543 fibroblast growth factor receptor signaling pathway                   0.5451919
## GO:0043087 regulation of GTPase activity                                         0.5481474
## GO:0042074 cell migration involved in gastrulation                               0.5481474
## GO:0002574 thrombocyte differentiation                                           0.5481474
## GO:0006357 regulation of transcription by RNA polymerase II                      0.5481474
## GO:0006940 regulation of smooth muscle contraction                               0.5481474
## GO:0035198 miRNA binding                                                         0.5481474
## GO:0035479 angioblast cell migration from lateral mesoderm to midline            0.5481474
## GO:0046580 negative regulation of Ras protein signal transduction                0.5481474
## GO:0007266 Rho protein signal transduction                                       0.5947356
##                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                   geneID
## GO:0005096 GTPase activator activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000021572/ENSPREG00000017857/ENSPREG00000016181/ENSPREG00000005604/ENSPREG00000020745/ENSPREG00000011984/ENSPREG00000021844/ENSPREG00000006159/ENSPREG00000013319/ENSPREG00000002871/ENSPREG00000014012/ENSPREG00000008818/ENSPREG00000004344/ENSPREG00000002721/ENSPREG00000018244/ENSPREG00000008275/ENSPREG00000006302/ENSPREG00000013392/ENSPREG00000008228/ENSPREG00000021641/ENSPREG00000016304/ENSPREG00000009970/ENSPREG00000019122/ENSPREG00000003783/ENSPREG00000010824/ENSPREG00000010160/ENSPREG00000021619/ENSPREG00000010031/ENSPREG00000011216/ENSPREG00000021253/ENSPREG00000006835/ENSPREG00000013232/ENSPREG00000022990/ENSPREG00000017023/ENSPREG00000014752/ENSPREG00000006207/ENSPREG00000003665/ENSPREG00000003620/ENSPREG00000010384
## GO:0043547 positive regulation of GTPase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                      ENSPREG00000021572/ENSPREG00000017857/ENSPREG00000016181/ENSPREG00000005604/ENSPREG00000020745/ENSPREG00000011984/ENSPREG00000021844/ENSPREG00000006159/ENSPREG00000013319/ENSPREG00000002871/ENSPREG00000014012/ENSPREG00000008818/ENSPREG00000004344/ENSPREG00000002721/ENSPREG00000018244/ENSPREG00000008275/ENSPREG00000006302/ENSPREG00000013392/ENSPREG00000008228/ENSPREG00000021641/ENSPREG00000016304/ENSPREG00000009970/ENSPREG00000019122/ENSPREG00000003783/ENSPREG00000010824/ENSPREG00000010160/ENSPREG00000021619/ENSPREG00000011216/ENSPREG00000021253/ENSPREG00000006835/ENSPREG00000013232/ENSPREG00000022990/ENSPREG00000017023/ENSPREG00000014752/ENSPREG00000006207/ENSPREG00000003665/ENSPREG00000003620/ENSPREG00000010384
## GO:0061053 somite development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                              ENSPREG00000004106/ENSPREG00000004421/ENSPREG00000019213/ENSPREG00000004734/ENSPREG00000021266/ENSPREG00000019454/ENSPREG00000014243/ENSPREG00000001029/ENSPREG00000019277/ENSPREG00000009696
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                                                                                                                                                                                                                                                                                                                 ENSPREG00000020178/ENSPREG00000001953/ENSPREG00000021717/ENSPREG00000006479/ENSPREG00000005993/ENSPREG00000018520/ENSPREG00000009681/ENSPREG00000006716/ENSPREG00000000920/ENSPREG00000015465/ENSPREG00000005368/ENSPREG00000005374/ENSPREG00000017783/ENSPREG00000020332/ENSPREG00000017205/ENSPREG00000014279/ENSPREG00000017596/ENSPREG00000013353/ENSPREG00000013766/ENSPREG00000016234/ENSPREG00000006819/ENSPREG00000020505/ENSPREG00000011391/ENSPREG00000012541/ENSPREG00000005821/ENSPREG00000001364/ENSPREG00000004970/ENSPREG00000022245/ENSPREG00000000568/ENSPREG00000003423/ENSPREG00000006660/ENSPREG00000013636/ENSPREG00000006396/ENSPREG00000020203/ENSPREG00000021337/ENSPREG00000020306/ENSPREG00000004613/ENSPREG00000006276/ENSPREG00000004738/ENSPREG00000000532/ENSPREG00000011115/ENSPREG00000000557/ENSPREG00000000563/ENSPREG00000023186/ENSPREG00000021486/ENSPREG00000020365/ENSPREG00000005380/ENSPREG00000021397/ENSPREG00000008763/ENSPREG00000001030/ENSPREG00000018023/ENSPREG00000011303/ENSPREG00000018702/ENSPREG00000017421/ENSPREG00000016284/ENSPREG00000006136
## GO:0030027 lamellipodium                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                       ENSPREG00000021380/ENSPREG00000019012/ENSPREG00000009577/ENSPREG00000009614/ENSPREG00000007947/ENSPREG00000004066/ENSPREG00000015792/ENSPREG00000003672/ENSPREG00000014493/ENSPREG00000014544/ENSPREG00000016267/ENSPREG00000019071/ENSPREG00000013594/ENSPREG00000012964
## GO:0008543 fibroblast growth factor receptor signaling pathway                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                          ENSPREG00000008601/ENSPREG00000006269/ENSPREG00000001888/ENSPREG00000001509/ENSPREG00000009500/ENSPREG00000009587/ENSPREG00000003136/ENSPREG00000012483/ENSPREG00000021677/ENSPREG00000003394/ENSPREG00000004531
## GO:0043087 regulation of GTPase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                   ENSPREG00000021572/ENSPREG00000017857/ENSPREG00000002871/ENSPREG00000014012/ENSPREG00000004344/ENSPREG00000018244/ENSPREG00000021641/ENSPREG00000010824/ENSPREG00000010160/ENSPREG00000011216
## GO:0042074 cell migration involved in gastrulation                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000011756/ENSPREG00000021881/ENSPREG00000006621/ENSPREG00000022282/ENSPREG00000004734/ENSPREG00000021266/ENSPREG00000018004/ENSPREG00000014148/ENSPREG00000021914/ENSPREG00000001363/ENSPREG00000021177/ENSPREG00000014260/ENSPREG00000008575
## GO:0002574 thrombocyte differentiation                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                    ENSPREG00000005604/ENSPREG00000004637/ENSPREG00000004734/ENSPREG00000021641/ENSPREG00000005463
## GO:0006357 regulation of transcription by RNA polymerase II                      ENSPREG00000020178/ENSPREG00000001953/ENSPREG00000021717/ENSPREG00000016394/ENSPREG00000000237/ENSPREG00000006479/ENSPREG00000018520/ENSPREG00000009681/ENSPREG00000000103/ENSPREG00000006716/ENSPREG00000000920/ENSPREG00000015465/ENSPREG00000020443/ENSPREG00000005368/ENSPREG00000005374/ENSPREG00000017783/ENSPREG00000020332/ENSPREG00000012529/ENSPREG00000017349/ENSPREG00000017205/ENSPREG00000014279/ENSPREG00000017596/ENSPREG00000013353/ENSPREG00000013766/ENSPREG00000006018/ENSPREG00000016234/ENSPREG00000002041/ENSPREG00000007490/ENSPREG00000006819/ENSPREG00000022140/ENSPREG00000020505/ENSPREG00000011391/ENSPREG00000012541/ENSPREG00000005821/ENSPREG00000001364/ENSPREG00000004970/ENSPREG00000019385/ENSPREG00000022245/ENSPREG00000000568/ENSPREG00000003423/ENSPREG00000006660/ENSPREG00000013636/ENSPREG00000008829/ENSPREG00000006396/ENSPREG00000020203/ENSPREG00000021337/ENSPREG00000020306/ENSPREG00000016198/ENSPREG00000004613/ENSPREG00000006276/ENSPREG00000021303/ENSPREG00000004738/ENSPREG00000000447/ENSPREG00000000532/ENSPREG00000011115/ENSPREG00000000557/ENSPREG00000000563/ENSPREG00000023186/ENSPREG00000021486/ENSPREG00000020365/ENSPREG00000019566/ENSPREG00000005380/ENSPREG00000018553/ENSPREG00000021397/ENSPREG00000001030/ENSPREG00000011303/ENSPREG00000007804/ENSPREG00000019158/ENSPREG00000018702/ENSPREG00000017421/ENSPREG00000016284/ENSPREG00000006136
## GO:0006940 regulation of smooth muscle contraction                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000017046/ENSPREG00000000530/ENSPREG00000019926/ENSPREG00000000294
## GO:0035198 miRNA binding                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                     ENSPREG00000020727/ENSPREG00000010315/ENSPREG00000002072/ENSPREG00000017699
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000004106/ENSPREG00000011756/ENSPREG00000010859/ENSPREG00000011785
## GO:0046580 negative regulation of Ras protein signal transduction                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                            ENSPREG00000017857/ENSPREG00000006469/ENSPREG00000004344/ENSPREG00000021641
## GO:0007266 Rho protein signal transduction                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                             ENSPREG00000013319/ENSPREG00000009253/ENSPREG00000008275/ENSPREG00000000371/ENSPREG00000017023/ENSPREG00000005721
##                                                                                  Count
## GO:0005096 GTPase activator activity                                                39
## GO:0043547 positive regulation of GTPase activity                                   38
## GO:0061053 somite development                                                       10
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific    56
## GO:0030027 lamellipodium                                                            14
## GO:0008543 fibroblast growth factor receptor signaling pathway                      11
## GO:0043087 regulation of GTPase activity                                            10
## GO:0042074 cell migration involved in gastrulation                                  13
## GO:0002574 thrombocyte differentiation                                               5
## GO:0006357 regulation of transcription by RNA polymerase II                         72
## GO:0006940 regulation of smooth muscle contraction                                   4
## GO:0035198 miRNA binding                                                             4
## GO:0035479 angioblast cell migration from lateral mesoderm to midline                4
## GO:0046580 negative regulation of Ras protein signal transduction                    4
## GO:0007266 Rho protein signal transduction                                           6
GvLunion <- union(GvL_up,GvL_dn)

c_union <- enricher(gene = GvLunion, universe = GvL_bg, minGSSize = 5,  maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_union,15)
##                                                                                                                                                                ID
## GO:0007275 multicellular organism development                                                                       GO:0007275 multicellular organism development
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0005096 GTPase activator activity                                                                                         GO:0005096 GTPase activator activity
## GO:0061053 somite development                                                                                                       GO:0061053 somite development
## GO:0043547 positive regulation of GTPase activity                                                               GO:0043547 positive regulation of GTPase activity
## GO:0005515 protein binding                                                                                                             GO:0005515 protein binding
## GO:0006357 regulation of transcription by RNA polymerase II                                           GO:0006357 regulation of transcription by RNA polymerase II
## GO:0042074 cell migration involved in gastrulation                                                             GO:0042074 cell migration involved in gastrulation
## GO:0036342 post-anal tail morphogenesis                                                                                   GO:0036342 post-anal tail morphogenesis
## GO:0005788 endoplasmic reticulum lumen                                                                                     GO:0005788 endoplasmic reticulum lumen
## GO:0006166 purine ribonucleoside salvage                                                                                 GO:0006166 purine ribonucleoside salvage
## GO:0006355 regulation of transcription, DNA-templated                                                       GO:0006355 regulation of transcription, DNA-templated
## GO:0016055 Wnt signaling pathway                                                                                                 GO:0016055 Wnt signaling pathway
## GO:0003690 double-stranded DNA binding                                                                                     GO:0003690 double-stranded DNA binding
## GO:0016651 oxidoreductase activity, acting on NAD(P)H                                                       GO:0016651 oxidoreductase activity, acting on NAD(P)H
##                                                                                                                                                       Description
## GO:0007275 multicellular organism development                                                                       GO:0007275 multicellular organism development
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0005096 GTPase activator activity                                                                                         GO:0005096 GTPase activator activity
## GO:0061053 somite development                                                                                                       GO:0061053 somite development
## GO:0043547 positive regulation of GTPase activity                                                               GO:0043547 positive regulation of GTPase activity
## GO:0005515 protein binding                                                                                                             GO:0005515 protein binding
## GO:0006357 regulation of transcription by RNA polymerase II                                           GO:0006357 regulation of transcription by RNA polymerase II
## GO:0042074 cell migration involved in gastrulation                                                             GO:0042074 cell migration involved in gastrulation
## GO:0036342 post-anal tail morphogenesis                                                                                   GO:0036342 post-anal tail morphogenesis
## GO:0005788 endoplasmic reticulum lumen                                                                                     GO:0005788 endoplasmic reticulum lumen
## GO:0006166 purine ribonucleoside salvage                                                                                 GO:0006166 purine ribonucleoside salvage
## GO:0006355 regulation of transcription, DNA-templated                                                       GO:0006355 regulation of transcription, DNA-templated
## GO:0016055 Wnt signaling pathway                                                                                                 GO:0016055 Wnt signaling pathway
## GO:0003690 double-stranded DNA binding                                                                                     GO:0003690 double-stranded DNA binding
## GO:0016651 oxidoreductase activity, acting on NAD(P)H                                                       GO:0016651 oxidoreductase activity, acting on NAD(P)H
##                                                                                  GeneRatio
## GO:0007275 multicellular organism development                                     200/5634
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific  114/5634
## GO:0005096 GTPase activator activity                                               67/5634
## GO:0061053 somite development                                                      16/5634
## GO:0043547 positive regulation of GTPase activity                                  66/5634
## GO:0005515 protein binding                                                       1132/5634
## GO:0006357 regulation of transcription by RNA polymerase II                       142/5634
## GO:0042074 cell migration involved in gastrulation                                 22/5634
## GO:0036342 post-anal tail morphogenesis                                            10/5634
## GO:0005788 endoplasmic reticulum lumen                                             14/5634
## GO:0006166 purine ribonucleoside salvage                                            6/5634
## GO:0006355 regulation of transcription, DNA-templated                             308/5634
## GO:0016055 Wnt signaling pathway                                                   42/5634
## GO:0003690 double-stranded DNA binding                                             10/5634
## GO:0016651 oxidoreductase activity, acting on NAD(P)H                               7/5634
##                                                                                     BgRatio
## GO:0007275 multicellular organism development                                     480/18091
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific  260/18091
## GO:0005096 GTPase activator activity                                              146/18091
## GO:0061053 somite development                                                      24/18091
## GO:0043547 positive regulation of GTPase activity                                 149/18091
## GO:0005515 protein binding                                                       3397/18091
## GO:0006357 regulation of transcription by RNA polymerase II                       370/18091
## GO:0042074 cell migration involved in gastrulation                                 41/18091
## GO:0036342 post-anal tail morphogenesis                                            14/18091
## GO:0005788 endoplasmic reticulum lumen                                             23/18091
## GO:0006166 purine ribonucleoside salvage                                            7/18091
## GO:0006355 regulation of transcription, DNA-templated                             875/18091
## GO:0016055 Wnt signaling pathway                                                   95/18091
## GO:0003690 double-stranded DNA binding                                             15/18091
## GO:0016651 oxidoreductase activity, acting on NAD(P)H                               9/18091
##                                                                                        pvalue
## GO:0007275 multicellular organism development                                    5.278263e-07
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 9.725663e-06
## GO:0005096 GTPase activator activity                                             1.241863e-04
## GO:0061053 somite development                                                    3.623042e-04
## GO:0043547 positive regulation of GTPase activity                                4.775609e-04
## GO:0005515 protein binding                                                       1.294484e-03
## GO:0006357 regulation of transcription by RNA polymerase II                      1.675474e-03
## GO:0042074 cell migration involved in gastrulation                               2.239310e-03
## GO:0036342 post-anal tail morphogenesis                                          2.278580e-03
## GO:0005788 endoplasmic reticulum lumen                                           3.072221e-03
## GO:0006166 purine ribonucleoside salvage                                         4.673959e-03
## GO:0006355 regulation of transcription, DNA-templated                            4.708250e-03
## GO:0016055 Wnt signaling pathway                                                 4.904310e-03
## GO:0003690 double-stranded DNA binding                                           4.929906e-03
## GO:0016651 oxidoreductase activity, acting on NAD(P)H                            5.414657e-03
##                                                                                      p.adjust
## GO:0007275 multicellular organism development                                    0.0009215848
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.0084905039
## GO:0005096 GTPase activator activity                                             0.0722763984
## GO:0061053 somite development                                                    0.1581457657
## GO:0043547 positive regulation of GTPase activity                                0.1667642787
## GO:0005515 protein binding                                                       0.3766947096
## GO:0006357 regulation of transcription by RNA polymerase II                      0.4179111344
## GO:0042074 cell migration involved in gastrulation                               0.4420445470
## GO:0036342 post-anal tail morphogenesis                                          0.4420445470
## GO:0005788 endoplasmic reticulum lumen                                           0.5364097324
## GO:0006166 purine ribonucleoside salvage                                         0.6044709455
## GO:0006355 regulation of transcription, DNA-templated                            0.6044709455
## GO:0016055 Wnt signaling pathway                                                 0.6044709455
## GO:0003690 double-stranded DNA binding                                           0.6044709455
## GO:0016651 oxidoreductase activity, acting on NAD(P)H                            0.6044709455
##                                                                                        qvalue
## GO:0007275 multicellular organism development                                    0.0009215848
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.0084905039
## GO:0005096 GTPase activator activity                                             0.0722763984
## GO:0061053 somite development                                                    0.1581457657
## GO:0043547 positive regulation of GTPase activity                                0.1667642787
## GO:0005515 protein binding                                                       0.3766947096
## GO:0006357 regulation of transcription by RNA polymerase II                      0.4179111344
## GO:0042074 cell migration involved in gastrulation                               0.4420445470
## GO:0036342 post-anal tail morphogenesis                                          0.4420445470
## GO:0005788 endoplasmic reticulum lumen                                           0.5364097324
## GO:0006166 purine ribonucleoside salvage                                         0.6044709455
## GO:0006355 regulation of transcription, DNA-templated                            0.6044709455
## GO:0016055 Wnt signaling pathway                                                 0.6044709455
## GO:0003690 double-stranded DNA binding                                           0.6044709455
## GO:0016651 oxidoreductase activity, acting on NAD(P)H                            0.6044709455
##                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                               geneID
## GO:0007275 multicellular organism development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000020203/ENSPREG00000021322/ENSPREG00000011367/ENSPREG00000001369/ENSPREG00000006929/ENSPREG00000007900/ENSPREG00000021725/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000003088/ENSPREG00000006767/ENSPREG00000012582/ENSPREG00000006315/ENSPREG00000000568/ENSPREG00000002117/ENSPREG00000000612/ENSPREG00000002795/ENSPREG00000011913/ENSPREG00000019795/ENSPREG00000013048/ENSPREG00000021144/ENSPREG00000009481/ENSPREG00000018023/ENSPREG00000019494/ENSPREG00000008962/ENSPREG00000016797/ENSPREG00000009349/ENSPREG00000010250/ENSPREG00000011561/ENSPREG00000013766/ENSPREG00000012325/ENSPREG00000015810/ENSPREG00000018652/ENSPREG00000012105/ENSPREG00000017347/ENSPREG00000007498/ENSPREG00000021106/ENSPREG00000006945/ENSPREG00000007342/ENSPREG00000011441/ENSPREG00000013058/ENSPREG00000006544/ENSPREG00000008377/ENSPREG00000005482/ENSPREG00000001072/ENSPREG00000021474/ENSPREG00000017440/ENSPREG00000011620/ENSPREG00000017582/ENSPREG00000019060/ENSPREG00000016476/ENSPREG00000016256/ENSPREG00000020385/ENSPREG00000023206/ENSPREG00000003325/ENSPREG00000012541/ENSPREG00000000290/ENSPREG00000019816/ENSPREG00000012697/ENSPREG00000022340/ENSPREG00000007061/ENSPREG00000015499/ENSPREG00000006276/ENSPREG00000000081/ENSPREG00000013353/ENSPREG00000012157/ENSPREG00000013812/ENSPREG00000011115/ENSPREG00000020206/ENSPREG00000009183/ENSPREG00000006008/ENSPREG00000018739/ENSPREG00000004544/ENSPREG00000019531/ENSPREG00000019774/ENSPREG00000005380/ENSPREG00000017388/ENSPREG00000006758/ENSPREG00000018360/ENSPREG00000018299/ENSPREG00000014903/ENSPREG00000009731/ENSPREG00000014120/ENSPREG00000020252/ENSPREG00000015465/ENSPREG00000005385/ENSPREG00000014657/ENSPREG00000009131/ENSPREG00000004067/ENSPREG00000006998/ENSPREG00000012420/ENSPREG00000015409/ENSPREG00000018757/ENSPREG00000008022/ENSPREG00000016630/ENSPREG00000008761/ENSPREG00000006631/ENSPREG00000015189/ENSPREG00000014784/ENSPREG00000009250/ENSPREG00000017666/ENSPREG00000002598/ENSPREG00000001334/ENSPREG00000010793/ENSPREG00000010872/ENSPREG00000007418/ENSPREG00000018822/ENSPREG00000016622/ENSPREG00000005412/ENSPREG00000018009/ENSPREG00000017718/ENSPREG00000013196/ENSPREG00000006981/ENSPREG00000008184/ENSPREG00000009155/ENSPREG00000006819/ENSPREG00000006806/ENSPREG00000015450/ENSPREG00000018004/ENSPREG00000021337/ENSPREG00000014891/ENSPREG00000002673/ENSPREG00000019962/ENSPREG00000000133/ENSPREG00000001918/ENSPREG00000011131/ENSPREG00000019762/ENSPREG00000009681/ENSPREG00000009942/ENSPREG00000006796/ENSPREG00000006388/ENSPREG00000002053/ENSPREG00000012707/ENSPREG00000019085/ENSPREG00000020178/ENSPREG00000021717/ENSPREG00000006469/ENSPREG00000004106/ENSPREG00000006479/ENSPREG00000011860/ENSPREG00000008534/ENSPREG00000001227/ENSPREG00000008016/ENSPREG00000010790/ENSPREG00000000691/ENSPREG00000018520/ENSPREG00000004862/ENSPREG00000023233/ENSPREG00000006716/ENSPREG00000009823/ENSPREG00000005368/ENSPREG00000005374/ENSPREG00000011756/ENSPREG00000001888/ENSPREG00000020332/ENSPREG00000014079/ENSPREG00000006190/ENSPREG00000021652/ENSPREG00000014279/ENSPREG00000017596/ENSPREG00000007694/ENSPREG00000016234/ENSPREG00000012787/ENSPREG00000020505/ENSPREG00000011391/ENSPREG00000008573/ENSPREG00000004734/ENSPREG00000005821/ENSPREG00000001364/ENSPREG00000004970/ENSPREG00000018675/ENSPREG00000013601/ENSPREG00000003672/ENSPREG00000012930/ENSPREG00000003423/ENSPREG00000006660/ENSPREG00000013636/ENSPREG00000006396/ENSPREG00000020306/ENSPREG00000007911/ENSPREG00000004613/ENSPREG00000016694/ENSPREG00000000532/ENSPREG00000006642/ENSPREG00000006326/ENSPREG00000000557/ENSPREG00000000563/ENSPREG00000023186/ENSPREG00000012819/ENSPREG00000020365/ENSPREG00000005189/ENSPREG00000017782/ENSPREG00000001030/ENSPREG00000011176/ENSPREG00000005657/ENSPREG00000018702/ENSPREG00000017421/ENSPREG00000008575/ENSPREG00000016284/ENSPREG00000006136
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                               ENSPREG00000020203/ENSPREG00000012188/ENSPREG00000019823/ENSPREG00000011367/ENSPREG00000006929/ENSPREG00000007900/ENSPREG00000021725/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000006767/ENSPREG00000006315/ENSPREG00000013067/ENSPREG00000000568/ENSPREG00000002117/ENSPREG00000009674/ENSPREG00000002795/ENSPREG00000019795/ENSPREG00000013048/ENSPREG00000018023/ENSPREG00000010250/ENSPREG00000013766/ENSPREG00000012325/ENSPREG00000015810/ENSPREG00000012105/ENSPREG00000007498/ENSPREG00000006945/ENSPREG00000011441/ENSPREG00000013058/ENSPREG00000005993/ENSPREG00000008377/ENSPREG00000017440/ENSPREG00000011620/ENSPREG00000021630/ENSPREG00000016256/ENSPREG00000003325/ENSPREG00000012541/ENSPREG00000000290/ENSPREG00000022340/ENSPREG00000006276/ENSPREG00000013353/ENSPREG00000013812/ENSPREG00000011115/ENSPREG00000019531/ENSPREG00000005380/ENSPREG00000006758/ENSPREG00000015465/ENSPREG00000005385/ENSPREG00000014657/ENSPREG00000006998/ENSPREG00000013765/ENSPREG00000012420/ENSPREG00000021486/ENSPREG00000006631/ENSPREG00000015189/ENSPREG00000009250/ENSPREG00000000644/ENSPREG00000017666/ENSPREG00000001334/ENSPREG00000015043/ENSPREG00000021574/ENSPREG00000013196/ENSPREG00000009155/ENSPREG00000006819/ENSPREG00000013623/ENSPREG00000000949/ENSPREG00000006806/ENSPREG00000015450/ENSPREG00000021337/ENSPREG00000019962/ENSPREG00000011131/ENSPREG00000009681/ENSPREG00000006796/ENSPREG00000006388/ENSPREG00000020178/ENSPREG00000001953/ENSPREG00000021717/ENSPREG00000006479/ENSPREG00000018520/ENSPREG00000006716/ENSPREG00000000920/ENSPREG00000005368/ENSPREG00000005374/ENSPREG00000017783/ENSPREG00000020332/ENSPREG00000017205/ENSPREG00000014279/ENSPREG00000017596/ENSPREG00000016234/ENSPREG00000020505/ENSPREG00000011391/ENSPREG00000005821/ENSPREG00000001364/ENSPREG00000004970/ENSPREG00000022245/ENSPREG00000003423/ENSPREG00000006660/ENSPREG00000013636/ENSPREG00000006396/ENSPREG00000020306/ENSPREG00000004613/ENSPREG00000004738/ENSPREG00000000532/ENSPREG00000000557/ENSPREG00000000563/ENSPREG00000023186/ENSPREG00000020365/ENSPREG00000021397/ENSPREG00000008763/ENSPREG00000001030/ENSPREG00000011303/ENSPREG00000018702/ENSPREG00000017421/ENSPREG00000016284/ENSPREG00000006136
## GO:0005096 GTPase activator activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000009673/ENSPREG00000002248/ENSPREG00000021844/ENSPREG00000013339/ENSPREG00000022339/ENSPREG00000014913/ENSPREG00000006440/ENSPREG00000013046/ENSPREG00000013249/ENSPREG00000021455/ENSPREG00000010031/ENSPREG00000011996/ENSPREG00000009432/ENSPREG00000020745/ENSPREG00000002317/ENSPREG00000013257/ENSPREG00000000815/ENSPREG00000010645/ENSPREG00000014547/ENSPREG00000020238/ENSPREG00000005509/ENSPREG00000008228/ENSPREG00000011216/ENSPREG00000007317/ENSPREG00000011807/ENSPREG00000001605/ENSPREG00000002871/ENSPREG00000022269/ENSPREG00000012301/ENSPREG00000019122/ENSPREG00000003273/ENSPREG00000021572/ENSPREG00000012665/ENSPREG00000000528/ENSPREG00000009884/ENSPREG00000001366/ENSPREG00000017857/ENSPREG00000016181/ENSPREG00000005604/ENSPREG00000011984/ENSPREG00000006159/ENSPREG00000013319/ENSPREG00000014012/ENSPREG00000008818/ENSPREG00000004344/ENSPREG00000002721/ENSPREG00000018244/ENSPREG00000008275/ENSPREG00000006302/ENSPREG00000013392/ENSPREG00000021641/ENSPREG00000016304/ENSPREG00000009970/ENSPREG00000003783/ENSPREG00000010824/ENSPREG00000010160/ENSPREG00000021619/ENSPREG00000021253/ENSPREG00000006835/ENSPREG00000013232/ENSPREG00000022990/ENSPREG00000017023/ENSPREG00000014752/ENSPREG00000006207/ENSPREG00000003665/ENSPREG00000003620/ENSPREG00000010384
## GO:0061053 somite development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000005012/ENSPREG00000006929/ENSPREG00000019213/ENSPREG00000021266/ENSPREG00000014803/ENSPREG00000020705/ENSPREG00000004233/ENSPREG00000003539/ENSPREG00000004106/ENSPREG00000004421/ENSPREG00000004734/ENSPREG00000019454/ENSPREG00000014243/ENSPREG00000001029/ENSPREG00000019277/ENSPREG00000009696
## GO:0043547 positive regulation of GTPase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                              ENSPREG00000009673/ENSPREG00000002248/ENSPREG00000021844/ENSPREG00000013339/ENSPREG00000022339/ENSPREG00000014913/ENSPREG00000006440/ENSPREG00000013046/ENSPREG00000013249/ENSPREG00000021455/ENSPREG00000011996/ENSPREG00000009432/ENSPREG00000020745/ENSPREG00000002317/ENSPREG00000013257/ENSPREG00000000815/ENSPREG00000010645/ENSPREG00000014547/ENSPREG00000020238/ENSPREG00000005509/ENSPREG00000008228/ENSPREG00000011216/ENSPREG00000007317/ENSPREG00000011807/ENSPREG00000001605/ENSPREG00000002871/ENSPREG00000022269/ENSPREG00000012301/ENSPREG00000019122/ENSPREG00000003273/ENSPREG00000021572/ENSPREG00000012665/ENSPREG00000000528/ENSPREG00000009884/ENSPREG00000001366/ENSPREG00000017857/ENSPREG00000016181/ENSPREG00000005604/ENSPREG00000011984/ENSPREG00000006159/ENSPREG00000013319/ENSPREG00000014012/ENSPREG00000008818/ENSPREG00000004344/ENSPREG00000002721/ENSPREG00000018244/ENSPREG00000008275/ENSPREG00000006302/ENSPREG00000013392/ENSPREG00000021641/ENSPREG00000016304/ENSPREG00000009970/ENSPREG00000003783/ENSPREG00000010824/ENSPREG00000010160/ENSPREG00000021619/ENSPREG00000021253/ENSPREG00000006835/ENSPREG00000013232/ENSPREG00000022990/ENSPREG00000017023/ENSPREG00000014752/ENSPREG00000006207/ENSPREG00000003665/ENSPREG00000003620/ENSPREG00000010384
## GO:0005515 protein binding                                                       ENSPREG00000004594/ENSPREG00000011953/ENSPREG00000012251/ENSPREG00000005998/ENSPREG00000012853/ENSPREG00000018477/ENSPREG00000019319/ENSPREG00000021322/ENSPREG00000001335/ENSPREG00000015471/ENSPREG00000017867/ENSPREG00000005048/ENSPREG00000002585/ENSPREG00000012822/ENSPREG00000006498/ENSPREG00000006662/ENSPREG00000009060/ENSPREG00000022512/ENSPREG00000013014/ENSPREG00000006443/ENSPREG00000014506/ENSPREG00000017977/ENSPREG00000012897/ENSPREG00000020661/ENSPREG00000021152/ENSPREG00000001239/ENSPREG00000007778/ENSPREG00000017204/ENSPREG00000002248/ENSPREG00000019970/ENSPREG00000020137/ENSPREG00000001142/ENSPREG00000009748/ENSPREG00000008576/ENSPREG00000016967/ENSPREG00000009420/ENSPREG00000023130/ENSPREG00000021756/ENSPREG00000012860/ENSPREG00000019090/ENSPREG00000004636/ENSPREG00000005315/ENSPREG00000001734/ENSPREG00000018881/ENSPREG00000002194/ENSPREG00000013460/ENSPREG00000017713/ENSPREG00000004055/ENSPREG00000003556/ENSPREG00000014973/ENSPREG00000011222/ENSPREG00000018815/ENSPREG00000021689/ENSPREG00000013339/ENSPREG00000010675/ENSPREG00000015324/ENSPREG00000006112/ENSPREG00000000629/ENSPREG00000019123/ENSPREG00000003610/ENSPREG00000012466/ENSPREG00000020310/ENSPREG00000000313/ENSPREG00000002366/ENSPREG00000013162/ENSPREG00000018168/ENSPREG00000009555/ENSPREG00000010398/ENSPREG00000012620/ENSPREG00000022961/ENSPREG00000018867/ENSPREG00000004777/ENSPREG00000022326/ENSPREG00000022339/ENSPREG00000009493/ENSPREG00000022133/ENSPREG00000019390/ENSPREG00000022366/ENSPREG00000019952/ENSPREG00000021215/ENSPREG00000006634/ENSPREG00000007157/ENSPREG00000016525/ENSPREG00000011896/ENSPREG00000009469/ENSPREG00000003508/ENSPREG00000003290/ENSPREG00000011758/ENSPREG00000000685/ENSPREG00000010125/ENSPREG00000006987/ENSPREG00000021622/ENSPREG00000002476/ENSPREG00000014608/ENSPREG00000001983/ENSPREG00000011064/ENSPREG00000001980/ENSPREG00000008778/ENSPREG00000000341/ENSPREG00000015155/ENSPREG00000020009/ENSPREG00000010341/ENSPREG00000017454/ENSPREG00000012413/ENSPREG00000014822/ENSPREG00000004263/ENSPREG00000008123/ENSPREG00000021865/ENSPREG00000020140/ENSPREG00000022616/ENSPREG00000004029/ENSPREG00000005051/ENSPREG00000019340/ENSPREG00000009666/ENSPREG00000004300/ENSPREG00000015991/ENSPREG00000011159/ENSPREG00000000588/ENSPREG00000010064/ENSPREG00000017657/ENSPREG00000006440/ENSPREG00000004736/ENSPREG00000022808/ENSPREG00000005875/ENSPREG00000000164/ENSPREG00000015245/ENSPREG00000011352/ENSPREG00000007731/ENSPREG00000001779/ENSPREG00000000954/ENSPREG00000014507/ENSPREG00000022767/ENSPREG00000007331/ENSPREG00000021401/ENSPREG00000006028/ENSPREG00000011331/ENSPREG00000015478/ENSPREG00000004312/ENSPREG00000022344/ENSPREG00000009801/ENSPREG00000000217/ENSPREG00000022594/ENSPREG00000018440/ENSPREG00000011036/ENSPREG00000013046/ENSPREG00000018664/ENSPREG00000001224/ENSPREG00000005794/ENSPREG00000003283/ENSPREG00000020701/ENSPREG00000003868/ENSPREG00000016489/ENSPREG00000007238/ENSPREG00000003115/ENSPREG00000013249/ENSPREG00000016307/ENSPREG00000007748/ENSPREG00000004285/ENSPREG00000018652/ENSPREG00000003639/ENSPREG00000006611/ENSPREG00000005611/ENSPREG00000004333/ENSPREG00000015114/ENSPREG00000006436/ENSPREG00000022747/ENSPREG00000020067/ENSPREG00000006682/ENSPREG00000001951/ENSPREG00000015233/ENSPREG00000005618/ENSPREG00000021106/ENSPREG00000021765/ENSPREG00000000779/ENSPREG00000010589/ENSPREG00000020380/ENSPREG00000020450/ENSPREG00000011954/ENSPREG00000012408/ENSPREG00000019635/ENSPREG00000017741/ENSPREG00000016502/ENSPREG00000013733/ENSPREG00000006914/ENSPREG00000021603/ENSPREG00000006544/ENSPREG00000002124/ENSPREG00000006678/ENSPREG00000008052/ENSPREG00000000950/ENSPREG00000001638/ENSPREG00000017444/ENSPREG00000021455/ENSPREG00000001482/ENSPREG00000010540/ENSPREG00000005421/ENSPREG00000013763/ENSPREG00000008274/ENSPREG00000013942/ENSPREG00000013074/ENSPREG00000022805/ENSPREG00000017574/ENSPREG00000011082/ENSPREG00000011132/ENSPREG00000018853/ENSPREG00000019044/ENSPREG00000017582/ENSPREG00000018413/ENSPREG00000022346/ENSPREG00000003053/ENSPREG00000003918/ENSPREG00000003789/ENSPREG00000010697/ENSPREG00000015905/ENSPREG00000017881/ENSPREG00000000593/ENSPREG00000017247/ENSPREG00000020214/ENSPREG00000002294/ENSPREG00000019665/ENSPREG00000010162/ENSPREG00000018599/ENSPREG00000018925/ENSPREG00000019676/ENSPREG00000007113/ENSPREG00000018426/ENSPREG00000010861/ENSPREG00000006420/ENSPREG00000020747/ENSPREG00000012900/ENSPREG00000002626/ENSPREG00000015822/ENSPREG00000020634/ENSPREG00000018410/ENSPREG00000005336/ENSPREG00000003791/ENSPREG00000007359/ENSPREG00000011865/ENSPREG00000022717/ENSPREG00000019594/ENSPREG00000005420/ENSPREG00000021324/ENSPREG00000005590/ENSPREG00000019957/ENSPREG00000002219/ENSPREG00000020729/ENSPREG00000019070/ENSPREG00000022577/ENSPREG00000021702/ENSPREG00000022909/ENSPREG00000019228/ENSPREG00000015809/ENSPREG00000016890/ENSPREG00000009910/ENSPREG00000021727/ENSPREG00000016174/ENSPREG00000002972/ENSPREG00000020325/ENSPREG00000003558/ENSPREG00000021213/ENSPREG00000019816/ENSPREG00000007115/ENSPREG00000004228/ENSPREG00000000181/ENSPREG00000006035/ENSPREG00000011389/ENSPREG00000020136/ENSPREG00000016562/ENSPREG00000009434/ENSPREG00000023195/ENSPREG00000016861/ENSPREG00000012846/ENSPREG00000022874/ENSPREG00000005952/ENSPREG00000021025/ENSPREG00000004576/ENSPREG00000000414/ENSPREG00000014698/ENSPREG00000020745/ENSPREG00000016294/ENSPREG00000019002/ENSPREG00000006655/ENSPREG00000006393/ENSPREG00000018452/ENSPREG00000021435/ENSPREG00000000059/ENSPREG00000019374/ENSPREG00000022590/ENSPREG00000017366/ENSPREG00000001790/ENSPREG00000015143/ENSPREG00000014141/ENSPREG00000006668/ENSPREG00000019417/ENSPREG00000020451/ENSPREG00000012167/ENSPREG00000011946/ENSPREG00000008293/ENSPREG00000021425/ENSPREG00000022224/ENSPREG00000017617/ENSPREG00000009091/ENSPREG00000000958/ENSPREG00000016663/ENSPREG00000013492/ENSPREG00000018266/ENSPREG00000005931/ENSPREG00000014503/ENSPREG00000018422/ENSPREG00000021256/ENSPREG00000011786/ENSPREG00000005086/ENSPREG00000013858/ENSPREG00000019186/ENSPREG00000018926/ENSPREG00000016295/ENSPREG00000017887/ENSPREG00000006438/ENSPREG00000013242/ENSPREG00000020456/ENSPREG00000000081/ENSPREG00000022222/ENSPREG00000009984/ENSPREG00000003979/ENSPREG00000023083/ENSPREG00000003561/ENSPREG00000006194/ENSPREG00000015626/ENSPREG00000022278/ENSPREG00000018891/ENSPREG00000000544/ENSPREG00000003003/ENSPREG00000022819/ENSPREG00000022570/ENSPREG00000004565/ENSPREG00000016136/ENSPREG00000011134/ENSPREG00000017179/ENSPREG00000005148/ENSPREG00000003987/ENSPREG00000017914/ENSPREG00000007601/ENSPREG00000011431/ENSPREG00000023244/ENSPREG00000019613/ENSPREG00000010712/ENSPREG00000016004/ENSPREG00000017448/ENSPREG00000010200/ENSPREG00000006669/ENSPREG00000012552/ENSPREG00000013262/ENSPREG00000004343/ENSPREG00000020971/ENSPREG00000015068/ENSPREG00000000817/ENSPREG00000020144/ENSPREG00000002199/ENSPREG00000009177/ENSPREG00000020784/ENSPREG00000005065/ENSPREG00000007903/ENSPREG00000017709/ENSPREG00000005185/ENSPREG00000018400/ENSPREG00000001725/ENSPREG00000022223/ENSPREG00000013653/ENSPREG00000009276/ENSPREG00000011322/ENSPREG00000011877/ENSPREG00000003965/ENSPREG00000004054/ENSPREG00000018739/ENSPREG00000002348/ENSPREG00000022836/ENSPREG00000014283/ENSPREG00000010225/ENSPREG00000016160/ENSPREG00000012500/ENSPREG00000008282/ENSPREG00000022372/ENSPREG00000016455/ENSPREG00000015764/ENSPREG00000005603/ENSPREG00000006253/ENSPREG00000018283/ENSPREG00000016542/ENSPREG00000012394/ENSPREG00000012534/ENSPREG00000023048/ENSPREG00000008155/ENSPREG00000020238/ENSPREG00000009226/ENSPREG00000021481/ENSPREG00000018360/ENSPREG00000007226/ENSPREG00000001594/ENSPREG00000020189/ENSPREG00000019101/ENSPREG00000018284/ENSPREG00000007523/ENSPREG00000014903/ENSPREG00000019086/ENSPREG00000015772/ENSPREG00000021020/ENSPREG00000010337/ENSPREG00000008825/ENSPREG00000012783/ENSPREG00000022843/ENSPREG00000016656/ENSPREG00000021224/ENSPREG00000005614/ENSPREG00000020252/ENSPREG00000002370/ENSPREG00000007974/ENSPREG00000002311/ENSPREG00000010930/ENSPREG00000008672/ENSPREG00000020167/ENSPREG00000022076/ENSPREG00000002771/ENSPREG00000002457/ENSPREG00000014625/ENSPREG00000009816/ENSPREG00000007713/ENSPREG00000014570/ENSPREG00000015652/ENSPREG00000002292/ENSPREG00000017550/ENSPREG00000001752/ENSPREG00000020768/ENSPREG00000006738/ENSPREG00000001563/ENSPREG00000019089/ENSPREG00000013300/ENSPREG00000011930/ENSPREG00000007324/ENSPREG00000014793/ENSPREG00000009793/ENSPREG00000018286/ENSPREG00000004067/ENSPREG00000010201/ENSPREG00000021218/ENSPREG00000022921/ENSPREG00000016483/ENSPREG00000017605/ENSPREG00000001336/ENSPREG00000018689/ENSPREG00000003692/ENSPREG00000020801/ENSPREG00000018552/ENSPREG00000017873/ENSPREG00000001741/ENSPREG00000022183/ENSPREG00000008213/ENSPREG00000002702/ENSPREG00000001939/ENSPREG00000008843/ENSPREG00000010997/ENSPREG00000012330/ENSPREG00000004374/ENSPREG00000010863/ENSPREG00000010771/ENSPREG00000022527/ENSPREG00000018757/ENSPREG00000014183/ENSPREG00000007319/ENSPREG00000008228/ENSPREG00000014668/ENSPREG00000017111/ENSPREG00000010516/ENSPREG00000022428/ENSPREG00000016577/ENSPREG00000010544/ENSPREG00000007496/ENSPREG00000021395/ENSPREG00000019656/ENSPREG00000022918/ENSPREG00000003604/ENSPREG00000005687/ENSPREG00000021439/ENSPREG00000021750/ENSPREG00000010047/ENSPREG00000018719/ENSPREG00000009526/ENSPREG00000021744/ENSPREG00000019860/ENSPREG00000008668/ENSPREG00000011196/ENSPREG00000019165/ENSPREG00000023240/ENSPREG00000009737/ENSPREG00000005820/ENSPREG00000016961/ENSPREG00000013496/ENSPREG00000016138/ENSPREG00000002905/ENSPREG00000004060/ENSPREG00000004632/ENSPREG00000015216/ENSPREG00000021179/ENSPREG00000003815/ENSPREG00000010951/ENSPREG00000002185/ENSPREG00000021321/ENSPREG00000000207/ENSPREG00000010817/ENSPREG00000011250/ENSPREG00000006378/ENSPREG00000008623/ENSPREG00000011108/ENSPREG00000001610/ENSPREG00000017365/ENSPREG00000021629/ENSPREG00000008027/ENSPREG00000020125/ENSPREG00000002598/ENSPREG00000014968/ENSPREG00000022018/ENSPREG00000002758/ENSPREG00000010975/ENSPREG00000017042/ENSPREG00000020542/ENSPREG00000005920/ENSPREG00000018229/ENSPREG00000019248/ENSPREG00000015541/ENSPREG00000022877/ENSPREG00000017095/ENSPREG00000008883/ENSPREG00000013631/ENSPREG00000020815/ENSPREG00000010793/ENSPREG00000020669/ENSPREG00000004391/ENSPREG00000002967/ENSPREG00000005457/ENSPREG00000015354/ENSPREG00000015192/ENSPREG00000002278/ENSPREG00000005450/ENSPREG00000012757/ENSPREG00000010745/ENSPREG00000000552/ENSPREG00000000614/ENSPREG00000008118/ENSPREG00000004233/ENSPREG00000000631/ENSPREG00000000664/ENSPREG00000017335/ENSPREG00000016007/ENSPREG00000015635/ENSPREG00000015338/ENSPREG00000018217/ENSPREG00000012544/ENSPREG00000021825/ENSPREG00000014040/ENSPREG00000023051/ENSPREG00000015389/ENSPREG00000012225/ENSPREG00000012158/ENSPREG00000013793/ENSPREG00000006529/ENSPREG00000013710/ENSPREG00000012958/ENSPREG00000003820/ENSPREG00000013129/ENSPREG00000002655/ENSPREG00000020433/ENSPREG00000019331/ENSPREG00000018661/ENSPREG00000007988/ENSPREG00000021217/ENSPREG00000005412/ENSPREG00000002047/ENSPREG00000018579/ENSPREG00000001094/ENSPREG00000004127/ENSPREG00000006550/ENSPREG00000012463/ENSPREG00000004302/ENSPREG00000009287/ENSPREG00000015411/ENSPREG00000009568/ENSPREG00000020231/ENSPREG00000010237/ENSPREG00000002204/ENSPREG00000007053/ENSPREG00000014117/ENSPREG00000014293/ENSPREG00000008917/ENSPREG00000016312/ENSPREG00000006981/ENSPREG00000008019/ENSPREG00000017396/ENSPREG00000003680/ENSPREG00000020583/ENSPREG00000002932/ENSPREG00000022000/ENSPREG00000008770/ENSPREG00000020152/ENSPREG00000021013/ENSPREG00000017431/ENSPREG00000015390/ENSPREG00000019122/ENSPREG00000005008/ENSPREG00000007168/ENSPREG00000017326/ENSPREG00000004666/ENSPREG00000002137/ENSPREG00000020279/ENSPREG00000005591/ENSPREG00000013171/ENSPREG00000000480/ENSPREG00000020803/ENSPREG00000012665/ENSPREG00000003037/ENSPREG00000017058/ENSPREG00000006578/ENSPREG00000015791/ENSPREG00000001070/ENSPREG00000013800/ENSPREG00000004172/ENSPREG00000006781/ENSPREG00000000452/ENSPREG00000007785/ENSPREG00000000528/ENSPREG00000010535/ENSPREG00000008848/ENSPREG00000022434/ENSPREG00000020590/ENSPREG00000014636/ENSPREG00000012373/ENSPREG00000003236/ENSPREG00000012273/ENSPREG00000018193/ENSPREG00000012401/ENSPREG00000017054/ENSPREG00000008187/ENSPREG00000009677/ENSPREG00000009497/ENSPREG00000002257/ENSPREG00000013980/ENSPREG00000010157/ENSPREG00000009366/ENSPREG00000005211/ENSPREG00000022741/ENSPREG00000018227/ENSPREG00000014532/ENSPREG00000019115/ENSPREG00000023140/ENSPREG00000008410/ENSPREG00000011957/ENSPREG00000009338/ENSPREG00000010850/ENSPREG00000009142/ENSPREG00000002898/ENSPREG00000014206/ENSPREG00000008157/ENSPREG00000005626/ENSPREG00000012024/ENSPREG00000020099/ENSPREG00000015823/ENSPREG00000004259/ENSPREG00000018641/ENSPREG00000010853/ENSPREG00000007682/ENSPREG00000013562/ENSPREG00000000485/ENSPREG00000012569/ENSPREG00000015203/ENSPREG00000000794/ENSPREG00000003169/ENSPREG00000008034/ENSPREG00000010979/ENSPREG00000014824/ENSPREG00000007689/ENSPREG00000016036/ENSPREG00000006583/ENSPREG00000010595/ENSPREG00000012696/ENSPREG00000015391/ENSPREG00000010973/ENSPREG00000008355/ENSPREG00000001918/ENSPREG00000022447/ENSPREG00000014490/ENSPREG00000001407/ENSPREG00000016063/ENSPREG00000020789/ENSPREG00000004395/ENSPREG00000020563/ENSPREG00000002175/ENSPREG00000007271/ENSPREG00000017893/ENSPREG00000011365/ENSPREG00000010886/ENSPREG00000022828/ENSPREG00000014338/ENSPREG00000018900/ENSPREG00000010345/ENSPREG00000000609/ENSPREG00000002053/ENSPREG00000011081/ENSPREG00000019038/ENSPREG00000000688/ENSPREG00000003630/ENSPREG00000022336/ENSPREG00000009089/ENSPREG00000020673/ENSPREG00000002203/ENSPREG00000011959/ENSPREG00000010772/ENSPREG00000018698/ENSPREG00000004325/ENSPREG00000000598/ENSPREG00000004080/ENSPREG00000010346/ENSPREG00000002929/ENSPREG00000021490/ENSPREG00000022867/ENSPREG00000000312/ENSPREG00000012615/ENSPREG00000012212/ENSPREG00000021620/ENSPREG00000016100/ENSPREG00000022506/ENSPREG00000013019/ENSPREG00000018231/ENSPREG00000021017/ENSPREG00000021380/ENSPREG00000006212/ENSPREG00000012566/ENSPREG00000008369/ENSPREG00000006391/ENSPREG00000006354/ENSPREG00000004354/ENSPREG00000018987/ENSPREG00000017705/ENSPREG00000011094/ENSPREG00000007097/ENSPREG00000020039/ENSPREG00000008541/ENSPREG00000005556/ENSPREG00000020727/ENSPREG00000011413/ENSPREG00000000237/ENSPREG00000019866/ENSPREG00000008775/ENSPREG00000008786/ENSPREG00000020410/ENSPREG00000019244/ENSPREG00000011271/ENSPREG00000022182/ENSPREG00000005525/ENSPREG00000007539/ENSPREG00000003222/ENSPREG00000004106/ENSPREG00000020859/ENSPREG00000003143/ENSPREG00000019151/ENSPREG00000012782/ENSPREG00000003150/ENSPREG00000015244/ENSPREG00000018444/ENSPREG00000018381/ENSPREG00000001415/ENSPREG00000002035/ENSPREG00000010315/ENSPREG00000008224/ENSPREG00000012617/ENSPREG00000013138/ENSPREG00000022200/ENSPREG00000000581/ENSPREG00000012133/ENSPREG00000018179/ENSPREG00000000926/ENSPREG00000017328/ENSPREG00000022413/ENSPREG00000019505/ENSPREG00000020047/ENSPREG00000017608/ENSPREG00000023057/ENSPREG00000016255/ENSPREG00000012268/ENSPREG00000014417/ENSPREG00000002384/ENSPREG00000002405/ENSPREG00000007301/ENSPREG00000000191/ENSPREG00000020473/ENSPREG00000017329/ENSPREG00000010511/ENSPREG00000020089/ENSPREG00000004424/ENSPREG00000014739/ENSPREG00000011701/ENSPREG00000007082/ENSPREG00000018883/ENSPREG00000014833/ENSPREG00000010790/ENSPREG00000002675/ENSPREG00000015724/ENSPREG00000000752/ENSPREG00000008982/ENSPREG00000004788/ENSPREG00000018631/ENSPREG00000002335/ENSPREG00000011556/ENSPREG00000000345/ENSPREG00000003437/ENSPREG00000011541/ENSPREG00000015882/ENSPREG00000013658/ENSPREG00000021731/ENSPREG00000002489/ENSPREG00000009732/ENSPREG00000014744/ENSPREG00000010109/ENSPREG00000017118/ENSPREG00000009336/ENSPREG00000019686/ENSPREG00000017801/ENSPREG00000017503/ENSPREG00000018240/ENSPREG00000014591/ENSPREG00000017257/ENSPREG00000003881/ENSPREG00000021150/ENSPREG00000008665/ENSPREG00000008539/ENSPREG00000022505/ENSPREG00000018865/ENSPREG00000016724/ENSPREG00000001041/ENSPREG00000022063/ENSPREG00000015048/ENSPREG00000009614/ENSPREG00000009811/ENSPREG00000021066/ENSPREG00000021411/ENSPREG00000023225/ENSPREG00000022710/ENSPREG00000007704/ENSPREG00000003373/ENSPREG00000005053/ENSPREG00000014889/ENSPREG00000007493/ENSPREG00000007885/ENSPREG00000018648/ENSPREG00000001247/ENSPREG00000014079/ENSPREG00000015540/ENSPREG00000000060/ENSPREG00000002613/ENSPREG00000001857/ENSPREG00000014483/ENSPREG00000018403/ENSPREG00000003369/ENSPREG00000004560/ENSPREG00000008818/ENSPREG00000004344/ENSPREG00000000681/ENSPREG00000019585/ENSPREG00000006060/ENSPREG00000004637/ENSPREG00000008925/ENSPREG00000009123/ENSPREG00000001973/ENSPREG00000007821/ENSPREG00000004221/ENSPREG00000007793/ENSPREG00000002580/ENSPREG00000019804/ENSPREG00000016073/ENSPREG00000020587/ENSPREG00000011692/ENSPREG00000006218/ENSPREG00000004477/ENSPREG00000015405/ENSPREG00000022641/ENSPREG00000013085/ENSPREG00000010460/ENSPREG00000015258/ENSPREG00000009218/ENSPREG00000019058/ENSPREG00000002184/ENSPREG00000015112/ENSPREG00000018348/ENSPREG00000016948/ENSPREG00000013491/ENSPREG00000008275/ENSPREG00000021573/ENSPREG00000021638/ENSPREG00000013886/ENSPREG00000007311/ENSPREG00000022933/ENSPREG00000007565/ENSPREG00000010550/ENSPREG00000005178/ENSPREG00000009203/ENSPREG00000020814/ENSPREG00000012218/ENSPREG00000004405/ENSPREG00000010405/ENSPREG00000008863/ENSPREG00000003963/ENSPREG00000016653/ENSPREG00000022162/ENSPREG00000000189/ENSPREG00000022931/ENSPREG00000015049/ENSPREG00000002735/ENSPREG00000022386/ENSPREG00000015761/ENSPREG00000019003/ENSPREG00000018584/ENSPREG00000011537/ENSPREG00000001669/ENSPREG00000008887/ENSPREG00000020749/ENSPREG00000008926/ENSPREG00000013392/ENSPREG00000019864/ENSPREG00000021889/ENSPREG00000004382/ENSPREG00000008151/ENSPREG00000016908/ENSPREG00000009185/ENSPREG00000021613/ENSPREG00000020399/ENSPREG00000023222/ENSPREG00000018522/ENSPREG00000022469/ENSPREG00000022480/ENSPREG00000009088/ENSPREG00000018797/ENSPREG00000007698/ENSPREG00000018609/ENSPREG00000004251/ENSPREG00000022213/ENSPREG00000011213/ENSPREG00000006188/ENSPREG00000015887/ENSPREG00000018675/ENSPREG00000009350/ENSPREG00000002962/ENSPREG00000003023/ENSPREG00000004187/ENSPREG00000005559/ENSPREG00000001278/ENSPREG00000014108/ENSPREG00000006673/ENSPREG00000009642/ENSPREG00000010127/ENSPREG00000020548/ENSPREG00000002936/ENSPREG00000005463/ENSPREG00000008742/ENSPREG00000010744/ENSPREG00000008562/ENSPREG00000008141/ENSPREG00000019567/ENSPREG00000021534/ENSPREG00000017407/ENSPREG00000005965/ENSPREG00000002444/ENSPREG00000002237/ENSPREG00000022797/ENSPREG00000002840/ENSPREG00000009572/ENSPREG00000009822/ENSPREG00000022622/ENSPREG00000007006/ENSPREG00000015880/ENSPREG00000000618/ENSPREG00000001363/ENSPREG00000021093/ENSPREG00000018533/ENSPREG00000009969/ENSPREG00000009536/ENSPREG00000003389/ENSPREG00000014146/ENSPREG00000022218/ENSPREG00000019533/ENSPREG00000001967/ENSPREG00000000180/ENSPREG00000001330/ENSPREG00000002547/ENSPREG00000014992/ENSPREG00000017143/ENSPREG00000020019/ENSPREG00000017655/ENSPREG00000019518/ENSPREG00000018764/ENSPREG00000014145/ENSPREG00000016570/ENSPREG00000006734/ENSPREG00000004754/ENSPREG00000012767/ENSPREG00000004894/ENSPREG00000012543/ENSPREG00000000684/ENSPREG00000009970/ENSPREG00000007911/ENSPREG00000020493/ENSPREG00000019208/ENSPREG00000006759/ENSPREG00000010824/ENSPREG00000008054/ENSPREG00000021880/ENSPREG00000012278/ENSPREG00000005899/ENSPREG00000010160/ENSPREG00000006530/ENSPREG00000021361/ENSPREG00000020693/ENSPREG00000022086/ENSPREG00000001861/ENSPREG00000021438/ENSPREG00000010003/ENSPREG00000021090/ENSPREG00000001766/ENSPREG00000016215/ENSPREG00000012811/ENSPREG00000007505/ENSPREG00000007268/ENSPREG00000021901/ENSPREG00000000736/ENSPREG00000000704/ENSPREG00000023095/ENSPREG00000017544/ENSPREG00000010720/ENSPREG00000010648/ENSPREG00000011191/ENSPREG00000002072/ENSPREG00000002971/ENSPREG00000022557/ENSPREG00000015415/ENSPREG00000020760/ENSPREG00000017266/ENSPREG00000017674/ENSPREG00000001373/ENSPREG00000017869/ENSPREG00000014069/ENSPREG00000017699/ENSPREG00000017993/ENSPREG00000003800/ENSPREG00000016756/ENSPREG00000007868/ENSPREG00000021962/ENSPREG00000002765/ENSPREG00000016750/ENSPREG00000012706/ENSPREG00000007921/ENSPREG00000021069/ENSPREG00000018225/ENSPREG00000006326/ENSPREG00000003216/ENSPREG00000018133/ENSPREG00000009274/ENSPREG00000018540/ENSPREG00000020581/ENSPREG00000013276/ENSPREG00000014043/ENSPREG00000015925/ENSPREG00000017260/ENSPREG00000003050/ENSPREG00000010417/ENSPREG00000007631/ENSPREG00000011641/ENSPREG00000002304/ENSPREG00000017458/ENSPREG00000002494/ENSPREG00000022493/ENSPREG00000017061/ENSPREG00000004963/ENSPREG00000007642/ENSPREG00000017954/ENSPREG00000014952/ENSPREG00000000234/ENSPREG00000014260/ENSPREG00000001754/ENSPREG00000001029/ENSPREG00000014995/ENSPREG00000021637/ENSPREG00000015146/ENSPREG00000012649/ENSPREG00000017023/ENSPREG00000011785/ENSPREG00000008680/ENSPREG00000021100/ENSPREG00000014612/ENSPREG00000007423/ENSPREG00000009449/ENSPREG00000017034/ENSPREG00000011040/ENSPREG00000006105/ENSPREG00000003403/ENSPREG00000013614/ENSPREG00000009441/ENSPREG00000006207/ENSPREG00000007314/ENSPREG00000003665/ENSPREG00000011050/ENSPREG00000013093/ENSPREG00000004946/ENSPREG00000016074/ENSPREG00000002963/ENSPREG00000018073/ENSPREG00000016690/ENSPREG00000003550/ENSPREG00000011176/ENSPREG00000005541/ENSPREG00000006235/ENSPREG00000021202/ENSPREG00000001785/ENSPREG00000009687/ENSPREG00000012037/ENSPREG00000005900/ENSPREG00000004552/ENSPREG00000013190/ENSPREG00000015740/ENSPREG00000010066/ENSPREG00000015006/ENSPREG00000017528/ENSPREG00000000279/ENSPREG00000000235/ENSPREG00000021915/ENSPREG00000021957/ENSPREG00000011709
## GO:0006357 regulation of transcription by RNA polymerase II                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000020203/ENSPREG00000012188/ENSPREG00000019823/ENSPREG00000011367/ENSPREG00000016198/ENSPREG00000006929/ENSPREG00000007900/ENSPREG00000021725/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000006767/ENSPREG00000006315/ENSPREG00000000568/ENSPREG00000002117/ENSPREG00000009674/ENSPREG00000017259/ENSPREG00000019479/ENSPREG00000002795/ENSPREG00000000103/ENSPREG00000019795/ENSPREG00000013048/ENSPREG00000013994/ENSPREG00000011064/ENSPREG00000010250/ENSPREG00000013766/ENSPREG00000012325/ENSPREG00000015810/ENSPREG00000012105/ENSPREG00000007498/ENSPREG00000006945/ENSPREG00000011441/ENSPREG00000013058/ENSPREG00000008377/ENSPREG00000000447/ENSPREG00000017440/ENSPREG00000011620/ENSPREG00000015905/ENSPREG00000019566/ENSPREG00000021630/ENSPREG00000016256/ENSPREG00000010684/ENSPREG00000003325/ENSPREG00000012541/ENSPREG00000000290/ENSPREG00000006934/ENSPREG00000022340/ENSPREG00000012296/ENSPREG00000009925/ENSPREG00000020764/ENSPREG00000006276/ENSPREG00000013353/ENSPREG00000011115/ENSPREG00000020206/ENSPREG00000003495/ENSPREG00000019531/ENSPREG00000005380/ENSPREG00000006758/ENSPREG00000015465/ENSPREG00000018746/ENSPREG00000005385/ENSPREG00000014657/ENSPREG00000006998/ENSPREG00000013765/ENSPREG00000012420/ENSPREG00000019537/ENSPREG00000021486/ENSPREG00000000847/ENSPREG00000006631/ENSPREG00000015189/ENSPREG00000009250/ENSPREG00000000644/ENSPREG00000001334/ENSPREG00000015043/ENSPREG00000021574/ENSPREG00000009155/ENSPREG00000006819/ENSPREG00000000949/ENSPREG00000006806/ENSPREG00000015450/ENSPREG00000021337/ENSPREG00000019962/ENSPREG00000020443/ENSPREG00000011131/ENSPREG00000011387/ENSPREG00000010836/ENSPREG00000009681/ENSPREG00000006796/ENSPREG00000006388/ENSPREG00000020178/ENSPREG00000001953/ENSPREG00000021717/ENSPREG00000016394/ENSPREG00000000237/ENSPREG00000006479/ENSPREG00000018520/ENSPREG00000006716/ENSPREG00000000920/ENSPREG00000005368/ENSPREG00000005374/ENSPREG00000017783/ENSPREG00000020332/ENSPREG00000012529/ENSPREG00000017349/ENSPREG00000017205/ENSPREG00000014279/ENSPREG00000017596/ENSPREG00000006018/ENSPREG00000016234/ENSPREG00000002041/ENSPREG00000007490/ENSPREG00000022140/ENSPREG00000020505/ENSPREG00000011391/ENSPREG00000005821/ENSPREG00000001364/ENSPREG00000004970/ENSPREG00000019385/ENSPREG00000022245/ENSPREG00000003423/ENSPREG00000006660/ENSPREG00000013636/ENSPREG00000008829/ENSPREG00000006396/ENSPREG00000020306/ENSPREG00000004613/ENSPREG00000021303/ENSPREG00000004738/ENSPREG00000000532/ENSPREG00000000557/ENSPREG00000000563/ENSPREG00000023186/ENSPREG00000020365/ENSPREG00000018553/ENSPREG00000021397/ENSPREG00000001030/ENSPREG00000011303/ENSPREG00000007804/ENSPREG00000019158/ENSPREG00000018702/ENSPREG00000017421/ENSPREG00000016284/ENSPREG00000006136
## GO:0042074 cell migration involved in gastrulation                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                 ENSPREG00000021266/ENSPREG00000022339/ENSPREG00000005116/ENSPREG00000011942/ENSPREG00000009636/ENSPREG00000018470/ENSPREG00000008022/ENSPREG00000001032/ENSPREG00000018004/ENSPREG00000009850/ENSPREG00000021177/ENSPREG00000009942/ENSPREG00000011756/ENSPREG00000021881/ENSPREG00000006621/ENSPREG00000022282/ENSPREG00000004734/ENSPREG00000014148/ENSPREG00000021914/ENSPREG00000001363/ENSPREG00000014260/ENSPREG00000008575
## GO:0036342 post-anal tail morphogenesis                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000021316/ENSPREG00000016545/ENSPREG00000014803/ENSPREG00000006631/ENSPREG00000003680/ENSPREG00000009155/ENSPREG00000007694/ENSPREG00000018936/ENSPREG00000004734/ENSPREG00000008575
## GO:0005788 endoplasmic reticulum lumen                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                     ENSPREG00000008313/ENSPREG00000009114/ENSPREG00000016136/ENSPREG00000015396/ENSPREG00000008623/ENSPREG00000003298/ENSPREG00000006623/ENSPREG00000015941/ENSPREG00000010003/ENSPREG00000017433/ENSPREG00000021079/ENSPREG00000014189/ENSPREG00000014288/ENSPREG00000005619
## GO:0006166 purine ribonucleoside salvage                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000022253/ENSPREG00000015439/ENSPREG00000003612/ENSPREG00000023054/ENSPREG00000021913/ENSPREG00000003051
## GO:0006355 regulation of transcription, DNA-templated                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                    ENSPREG00000020203/ENSPREG00000012188/ENSPREG00000019823/ENSPREG00000011367/ENSPREG00000004628/ENSPREG00000006929/ENSPREG00000003428/ENSPREG00000007900/ENSPREG00000011918/ENSPREG00000021725/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000006767/ENSPREG00000012582/ENSPREG00000006315/ENSPREG00000000922/ENSPREG00000005246/ENSPREG00000013067/ENSPREG00000022267/ENSPREG00000009351/ENSPREG00000018881/ENSPREG00000000568/ENSPREG00000002117/ENSPREG00000009674/ENSPREG00000014960/ENSPREG00000002795/ENSPREG00000011913/ENSPREG00000019795/ENSPREG00000000313/ENSPREG00000013048/ENSPREG00000010086/ENSPREG00000018023/ENSPREG00000021553/ENSPREG00000022723/ENSPREG00000014608/ENSPREG00000011064/ENSPREG00000014097/ENSPREG00000022546/ENSPREG00000003440/ENSPREG00000004029/ENSPREG00000005028/ENSPREG00000016797/ENSPREG00000010250/ENSPREG00000013386/ENSPREG00000017016/ENSPREG00000013766/ENSPREG00000008667/ENSPREG00000008815/ENSPREG00000021316/ENSPREG00000012325/ENSPREG00000017021/ENSPREG00000015810/ENSPREG00000013403/ENSPREG00000011212/ENSPREG00000012105/ENSPREG00000007498/ENSPREG00000006945/ENSPREG00000016676/ENSPREG00000007342/ENSPREG00000009326/ENSPREG00000011441/ENSPREG00000019519/ENSPREG00000013058/ENSPREG00000006544/ENSPREG00000008377/ENSPREG00000007906/ENSPREG00000017440/ENSPREG00000011620/ENSPREG00000017582/ENSPREG00000003918/ENSPREG00000015905/ENSPREG00000017247/ENSPREG00000011942/ENSPREG00000010162/ENSPREG00000018925/ENSPREG00000019566/ENSPREG00000021630/ENSPREG00000001543/ENSPREG00000016256/ENSPREG00000022772/ENSPREG00000023206/ENSPREG00000003325/ENSPREG00000012541/ENSPREG00000023148/ENSPREG00000011231/ENSPREG00000000290/ENSPREG00000017649/ENSPREG00000015654/ENSPREG00000016146/ENSPREG00000003063/ENSPREG00000015395/ENSPREG00000018974/ENSPREG00000007429/ENSPREG00000022340/ENSPREG00000011269/ENSPREG00000007997/ENSPREG00000015499/ENSPREG00000017887/ENSPREG00000006276/ENSPREG00000002822/ENSPREG00000013353/ENSPREG00000021982/ENSPREG00000022365/ENSPREG00000010841/ENSPREG00000009008/ENSPREG00000023244/ENSPREG00000017352/ENSPREG00000013812/ENSPREG00000011115/ENSPREG00000022066/ENSPREG00000011877/ENSPREG00000021136/ENSPREG00000019531/ENSPREG00000020804/ENSPREG00000004768/ENSPREG00000004398/ENSPREG00000005380/ENSPREG00000012965/ENSPREG00000002259/ENSPREG00000006758/ENSPREG00000009056/ENSPREG00000009731/ENSPREG00000001226/ENSPREG00000014803/ENSPREG00000015465/ENSPREG00000021052/ENSPREG00000018746/ENSPREG00000005385/ENSPREG00000014657/ENSPREG00000009131/ENSPREG00000011496/ENSPREG00000008402/ENSPREG00000011930/ENSPREG00000022910/ENSPREG00000002926/ENSPREG00000008997/ENSPREG00000006998/ENSPREG00000021362/ENSPREG00000012420/ENSPREG00000008972/ENSPREG00000010182/ENSPREG00000019537/ENSPREG00000020466/ENSPREG00000015409/ENSPREG00000000847/ENSPREG00000008918/ENSPREG00000022501/ENSPREG00000008761/ENSPREG00000018558/ENSPREG00000000792/ENSPREG00000006455/ENSPREG00000011189/ENSPREG00000006631/ENSPREG00000007784/ENSPREG00000015189/ENSPREG00000017365/ENSPREG00000007884/ENSPREG00000014784/ENSPREG00000009250/ENSPREG00000000644/ENSPREG00000017666/ENSPREG00000000434/ENSPREG00000001334/ENSPREG00000015981/ENSPREG00000011732/ENSPREG00000021574/ENSPREG00000014207/ENSPREG00000013196/ENSPREG00000020992/ENSPREG00000010818/ENSPREG00000003680/ENSPREG00000016863/ENSPREG00000022630/ENSPREG00000005038/ENSPREG00000009155/ENSPREG00000005008/ENSPREG00000006819/ENSPREG00000013848/ENSPREG00000013623/ENSPREG00000022317/ENSPREG00000009052/ENSPREG00000010581/ENSPREG00000013800/ENSPREG00000006806/ENSPREG00000011546/ENSPREG00000018249/ENSPREG00000015450/ENSPREG00000018193/ENSPREG00000009850/ENSPREG00000022410/ENSPREG00000021337/ENSPREG00000019455/ENSPREG00000019962/ENSPREG00000010102/ENSPREG00000011131/ENSPREG00000019762/ENSPREG00000011387/ENSPREG00000005818/ENSPREG00000009681/ENSPREG00000018056/ENSPREG00000011677/ENSPREG00000006796/ENSPREG00000006388/ENSPREG00000002487/ENSPREG00000018453/ENSPREG00000011959/ENSPREG00000004232/ENSPREG00000020178/ENSPREG00000001953/ENSPREG00000019840/ENSPREG00000004380/ENSPREG00000021717/ENSPREG00000022182/ENSPREG00000006479/ENSPREG00000015213/ENSPREG00000008224/ENSPREG00000023177/ENSPREG00000023202/ENSPREG00000020875/ENSPREG00000021173/ENSPREG00000000691/ENSPREG00000018520/ENSPREG00000017420/ENSPREG00000004655/ENSPREG00000006716/ENSPREG00000009240/ENSPREG00000005368/ENSPREG00000005374/ENSPREG00000017783/ENSPREG00000014431/ENSPREG00000012138/ENSPREG00000016918/ENSPREG00000020332/ENSPREG00000021778/ENSPREG00000007328/ENSPREG00000006142/ENSPREG00000019735/ENSPREG00000018565/ENSPREG00000003655/ENSPREG00000007793/ENSPREG00000017205/ENSPREG00000014279/ENSPREG00000017596/ENSPREG00000009359/ENSPREG00000016234/ENSPREG00000001598/ENSPREG00000014517/ENSPREG00000013440/ENSPREG00000008720/ENSPREG00000020505/ENSPREG00000011391/ENSPREG00000005821/ENSPREG00000008483/ENSPREG00000023222/ENSPREG00000018134/ENSPREG00000018224/ENSPREG00000001364/ENSPREG00000013420/ENSPREG00000004970/ENSPREG00000013601/ENSPREG00000019385/ENSPREG00000022245/ENSPREG00000003901/ENSPREG00000003423/ENSPREG00000006660/ENSPREG00000009822/ENSPREG00000000204/ENSPREG00000013636/ENSPREG00000008829/ENSPREG00000006396/ENSPREG00000016361/ENSPREG00000020306/ENSPREG00000006034/ENSPREG00000019055/ENSPREG00000013455/ENSPREG00000005784/ENSPREG00000004613/ENSPREG00000019967/ENSPREG00000004738/ENSPREG00000017180/ENSPREG00000014867/ENSPREG00000000532/ENSPREG00000012266/ENSPREG00000005434/ENSPREG00000006326/ENSPREG00000004404/ENSPREG00000000557/ENSPREG00000000563/ENSPREG00000023186/ENSPREG00000015916/ENSPREG00000020365/ENSPREG00000008490/ENSPREG00000000957/ENSPREG00000004772/ENSPREG00000003528/ENSPREG00000005256/ENSPREG00000002132/ENSPREG00000001030/ENSPREG00000009379/ENSPREG00000018100/ENSPREG00000008985/ENSPREG00000011303/ENSPREG00000018702/ENSPREG00000017421/ENSPREG00000014317/ENSPREG00000017478/ENSPREG00000016284/ENSPREG00000006136
## GO:0016055 Wnt signaling pathway                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                       ENSPREG00000009481/ENSPREG00000006907/ENSPREG00000011561/ENSPREG00000021316/ENSPREG00000005116/ENSPREG00000021106/ENSPREG00000019060/ENSPREG00000020385/ENSPREG00000020987/ENSPREG00000000958/ENSPREG00000000081/ENSPREG00000018739/ENSPREG00000009636/ENSPREG00000017388/ENSPREG00000014903/ENSPREG00000002723/ENSPREG00000005920/ENSPREG00000017718/ENSPREG00000008184/ENSPREG00000006329/ENSPREG00000000741/ENSPREG00000018004/ENSPREG00000019868/ENSPREG00000002673/ENSPREG00000009942/ENSPREG00000002053/ENSPREG00000011860/ENSPREG00000018405/ENSPREG00000001888/ENSPREG00000014079/ENSPREG00000010495/ENSPREG00000007694/ENSPREG00000022656/ENSPREG00000004734/ENSPREG00000012847/ENSPREG00000002332/ENSPREG00000004323/ENSPREG00000001731/ENSPREG00000020735/ENSPREG00000000736/ENSPREG00000007804/ENSPREG00000011176
## GO:0003690 double-stranded DNA binding                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                 ENSPREG00000003088/ENSPREG00000017119/ENSPREG00000015766/ENSPREG00000000378/ENSPREG00000019200/ENSPREG00000021052/ENSPREG00000019537/ENSPREG00000020992/ENSPREG00000022245/ENSPREG00000023099
## GO:0016651 oxidoreductase activity, acting on NAD(P)H                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000000871/ENSPREG00000009567/ENSPREG00000005882/ENSPREG00000017416/ENSPREG00000012893/ENSPREG00000011596/ENSPREG00000001667
##                                                                                  Count
## GO:0007275 multicellular organism development                                      200
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific   114
## GO:0005096 GTPase activator activity                                                67
## GO:0061053 somite development                                                       16
## GO:0043547 positive regulation of GTPase activity                                   66
## GO:0005515 protein binding                                                        1132
## GO:0006357 regulation of transcription by RNA polymerase II                        142
## GO:0042074 cell migration involved in gastrulation                                  22
## GO:0036342 post-anal tail morphogenesis                                             10
## GO:0005788 endoplasmic reticulum lumen                                              14
## GO:0006166 purine ribonucleoside salvage                                             6
## GO:0006355 regulation of transcription, DNA-templated                              308
## GO:0016055 Wnt signaling pathway                                                    42
## GO:0003690 double-stranded DNA binding                                              10
## GO:0016651 oxidoreductase activity, acting on NAD(P)H                                7
library(reshape2)


GvL_up <- subset(GvL,meth.diff>0&qvalue<0.001)
GvL_up <- unique(GvL_up$gene_id)
str(GvL_up)
##  chr [1:833] "ENSPREG00000002699" "ENSPREG00000004582" "ENSPREG00000004594" ...
GvL_dn <- subset(GvL,meth.diff<0&qvalue<0.001)
GvL_dn <- unique(GvL_dn$gene_id)
str(CvL_dn)
##  chr [1:763] "ENSPREG00000014846" "ENSPREG00000010182" "ENSPREG00000012722" ...
GvL_bg <- unique(GvL$gene_id)
str(GvL_bg)
##  chr [1:21615] "ENSPREG00000021468" "ENSPREG00000021490" ...
c_up <- enricher(gene = GvL_up, universe = GvL_bg, minGSSize = 5, maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_up,15)
##                                                                                                                                                                      ID
## GO:0030168 platelet activation                                                                                                           GO:0030168 platelet activation
## GO:0003677 DNA binding                                                                                                                           GO:0003677 DNA binding
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific       GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0006357 regulation of transcription by RNA polymerase II                                                 GO:0006357 regulation of transcription by RNA polymerase II
## GO:0006355 regulation of transcription, DNA-templated                                                             GO:0006355 regulation of transcription, DNA-templated
## GO:0007275 multicellular organism development                                                                             GO:0007275 multicellular organism development
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific
## GO:0030182 neuron differentiation                                                                                                     GO:0030182 neuron differentiation
## GO:0016567 protein ubiquitination                                                                                                     GO:0016567 protein ubiquitination
## GO:0005634 nucleus                                                                                                                                   GO:0005634 nucleus
## GO:0003700 DNA-binding transcription factor activity                                                               GO:0003700 DNA-binding transcription factor activity
## GO:0061053 somite development                                                                                                             GO:0061053 somite development
## GO:0000439 transcription factor TFIIH core complex                                                                   GO:0000439 transcription factor TFIIH core complex
## GO:0003160 endocardium morphogenesis                                                                                               GO:0003160 endocardium morphogenesis
## GO:0006384 transcription initiation from RNA polymerase III promoter                               GO:0006384 transcription initiation from RNA polymerase III promoter
##                                                                                                                                                             Description
## GO:0030168 platelet activation                                                                                                           GO:0030168 platelet activation
## GO:0003677 DNA binding                                                                                                                           GO:0003677 DNA binding
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific       GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0006357 regulation of transcription by RNA polymerase II                                                 GO:0006357 regulation of transcription by RNA polymerase II
## GO:0006355 regulation of transcription, DNA-templated                                                             GO:0006355 regulation of transcription, DNA-templated
## GO:0007275 multicellular organism development                                                                             GO:0007275 multicellular organism development
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific
## GO:0030182 neuron differentiation                                                                                                     GO:0030182 neuron differentiation
## GO:0016567 protein ubiquitination                                                                                                     GO:0016567 protein ubiquitination
## GO:0005634 nucleus                                                                                                                                   GO:0005634 nucleus
## GO:0003700 DNA-binding transcription factor activity                                                               GO:0003700 DNA-binding transcription factor activity
## GO:0061053 somite development                                                                                                             GO:0061053 somite development
## GO:0000439 transcription factor TFIIH core complex                                                                   GO:0000439 transcription factor TFIIH core complex
## GO:0003160 endocardium morphogenesis                                                                                               GO:0003160 endocardium morphogenesis
## GO:0006384 transcription initiation from RNA polymerase III promoter                               GO:0006384 transcription initiation from RNA polymerase III promoter
##                                                                                     GeneRatio
## GO:0030168 platelet activation                                                          4/712
## GO:0003677 DNA binding                                                                 68/712
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific       22/712
## GO:0006357 regulation of transcription by RNA polymerase II                            26/712
## GO:0006355 regulation of transcription, DNA-templated                                  51/712
## GO:0007275 multicellular organism development                                          31/712
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific     3/712
## GO:0030182 neuron differentiation                                                       4/712
## GO:0016567 protein ubiquitination                                                      18/712
## GO:0005634 nucleus                                                                    104/712
## GO:0003700 DNA-binding transcription factor activity                                   29/712
## GO:0061053 somite development                                                           4/712
## GO:0000439 transcription factor TFIIH core complex                                      2/712
## GO:0003160 endocardium morphogenesis                                                    2/712
## GO:0006384 transcription initiation from RNA polymerase III promoter                    2/712
##                                                                                        BgRatio
## GO:0030168 platelet activation                                                         7/18091
## GO:0003677 DNA binding                                                              1131/18091
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific     260/18091
## GO:0006357 regulation of transcription by RNA polymerase II                          370/18091
## GO:0006355 regulation of transcription, DNA-templated                                875/18091
## GO:0007275 multicellular organism development                                        480/18091
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific   10/18091
## GO:0030182 neuron differentiation                                                     20/18091
## GO:0016567 protein ubiquitination                                                    242/18091
## GO:0005634 nucleus                                                                  2108/18091
## GO:0003700 DNA-binding transcription factor activity                                 463/18091
## GO:0061053 somite development                                                         24/18091
## GO:0000439 transcription factor TFIIH core complex                                     5/18091
## GO:0003160 endocardium morphogenesis                                                   5/18091
## GO:0006384 transcription initiation from RNA polymerase III promoter                   5/18091
##                                                                                           pvalue
## GO:0030168 platelet activation                                                      7.572133e-05
## GO:0003677 DNA binding                                                              3.143756e-04
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific    6.437373e-04
## GO:0006357 regulation of transcription by RNA polymerase II                         3.243720e-03
## GO:0006355 regulation of transcription, DNA-templated                               3.310674e-03
## GO:0007275 multicellular organism development                                       4.921780e-03
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific 5.919894e-03
## GO:0030182 neuron differentiation                                                   6.966722e-03
## GO:0016567 protein ubiquitination                                                   7.460950e-03
## GO:0005634 nucleus                                                                  8.546049e-03
## GO:0003700 DNA-binding transcription factor activity                                9.576247e-03
## GO:0061053 somite development                                                       1.349559e-02
## GO:0000439 transcription factor TFIIH core complex                                  1.428954e-02
## GO:0003160 endocardium morphogenesis                                                1.428954e-02
## GO:0006384 transcription initiation from RNA polymerase III promoter                1.428954e-02
##                                                                                       p.adjust
## GO:0030168 platelet activation                                                      0.06194005
## GO:0003677 DNA binding                                                              0.12857964
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific    0.17552570
## GO:0006357 regulation of transcription by RNA polymerase II                         0.52170357
## GO:0006355 regulation of transcription, DNA-templated                               0.52170357
## GO:0007275 multicellular organism development                                       0.52170357
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific 0.52170357
## GO:0030182 neuron differentiation                                                   0.52170357
## GO:0016567 protein ubiquitination                                                   0.52170357
## GO:0005634 nucleus                                                                  0.52170357
## GO:0003700 DNA-binding transcription factor activity                                0.52170357
## GO:0061053 somite development                                                       0.52170357
## GO:0000439 transcription factor TFIIH core complex                                  0.52170357
## GO:0003160 endocardium morphogenesis                                                0.52170357
## GO:0006384 transcription initiation from RNA polymerase III promoter                0.52170357
##                                                                                         qvalue
## GO:0030168 platelet activation                                                      0.05970029
## GO:0003677 DNA binding                                                              0.12393019
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific    0.16917867
## GO:0006357 regulation of transcription by RNA polymerase II                         0.50283872
## GO:0006355 regulation of transcription, DNA-templated                               0.50283872
## GO:0007275 multicellular organism development                                       0.50283872
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific 0.50283872
## GO:0030182 neuron differentiation                                                   0.50283872
## GO:0016567 protein ubiquitination                                                   0.50283872
## GO:0005634 nucleus                                                                  0.50283872
## GO:0003700 DNA-binding transcription factor activity                                0.50283872
## GO:0061053 somite development                                                       0.50283872
## GO:0000439 transcription factor TFIIH core complex                                  0.50283872
## GO:0003160 endocardium morphogenesis                                                0.50283872
## GO:0006384 transcription initiation from RNA polymerase III promoter                0.50283872
##                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                      geneID
## GO:0030168 platelet activation                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                  ENSPREG00000017046/ENSPREG00000014506/ENSPREG00000000530/ENSPREG00000002789
## GO:0003677 DNA binding                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                          ENSPREG00000022956/ENSPREG00000020203/ENSPREG00000012188/ENSPREG00000004595/ENSPREG00000011367/ENSPREG00000001369/ENSPREG00000016198/ENSPREG00000004628/ENSPREG00000006929/ENSPREG00000003428/ENSPREG00000018820/ENSPREG00000010940/ENSPREG00000007900/ENSPREG00000011918/ENSPREG00000014413/ENSPREG00000021725/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000003088/ENSPREG00000006767/ENSPREG00000012582/ENSPREG00000020394/ENSPREG00000006315/ENSPREG00000000922/ENSPREG00000013067/ENSPREG00000022267/ENSPREG00000009351/ENSPREG00000004107/ENSPREG00000018881/ENSPREG00000000568/ENSPREG00000002117/ENSPREG00000009674/ENSPREG00000014960/ENSPREG00000019479/ENSPREG00000002795/ENSPREG00000022924/ENSPREG00000011913/ENSPREG00000019795/ENSPREG00000004425/ENSPREG00000012831/ENSPREG00000013048/ENSPREG00000011292/ENSPREG00000018023/ENSPREG00000007715/ENSPREG00000021553/ENSPREG00000022723/ENSPREG00000011064/ENSPREG00000007733/ENSPREG00000004023/ENSPREG00000010341/ENSPREG00000011157/ENSPREG00000006460/ENSPREG00000004029/ENSPREG00000016797/ENSPREG00000015341/ENSPREG00000010250/ENSPREG00000013386/ENSPREG00000017016/ENSPREG00000001592/ENSPREG00000013766/ENSPREG00000015491/ENSPREG00000004266/ENSPREG00000008667/ENSPREG00000008815/ENSPREG00000002849/ENSPREG00000020701/ENSPREG00000012325/ENSPREG00000021691
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                          ENSPREG00000020203/ENSPREG00000012188/ENSPREG00000019823/ENSPREG00000011367/ENSPREG00000006929/ENSPREG00000007900/ENSPREG00000021725/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000006767/ENSPREG00000006315/ENSPREG00000013067/ENSPREG00000000568/ENSPREG00000002117/ENSPREG00000009674/ENSPREG00000002795/ENSPREG00000019795/ENSPREG00000013048/ENSPREG00000018023/ENSPREG00000010250/ENSPREG00000013766/ENSPREG00000012325
## GO:0006357 regulation of transcription by RNA polymerase II                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                   ENSPREG00000020203/ENSPREG00000012188/ENSPREG00000019823/ENSPREG00000011367/ENSPREG00000016198/ENSPREG00000006929/ENSPREG00000007900/ENSPREG00000021725/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000006767/ENSPREG00000006315/ENSPREG00000000568/ENSPREG00000002117/ENSPREG00000009674/ENSPREG00000017259/ENSPREG00000019479/ENSPREG00000002795/ENSPREG00000000103/ENSPREG00000019795/ENSPREG00000013048/ENSPREG00000013994/ENSPREG00000011064/ENSPREG00000010250/ENSPREG00000013766/ENSPREG00000012325
## GO:0006355 regulation of transcription, DNA-templated                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                              ENSPREG00000020203/ENSPREG00000012188/ENSPREG00000019823/ENSPREG00000011367/ENSPREG00000004628/ENSPREG00000006929/ENSPREG00000003428/ENSPREG00000007900/ENSPREG00000011918/ENSPREG00000021725/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000006767/ENSPREG00000012582/ENSPREG00000006315/ENSPREG00000000922/ENSPREG00000005246/ENSPREG00000013067/ENSPREG00000022267/ENSPREG00000009351/ENSPREG00000018881/ENSPREG00000000568/ENSPREG00000002117/ENSPREG00000009674/ENSPREG00000014960/ENSPREG00000002795/ENSPREG00000011913/ENSPREG00000019795/ENSPREG00000000313/ENSPREG00000013048/ENSPREG00000010086/ENSPREG00000018023/ENSPREG00000021553/ENSPREG00000022723/ENSPREG00000014608/ENSPREG00000011064/ENSPREG00000014097/ENSPREG00000022546/ENSPREG00000003440/ENSPREG00000004029/ENSPREG00000005028/ENSPREG00000016797/ENSPREG00000010250/ENSPREG00000013386/ENSPREG00000017016/ENSPREG00000013766/ENSPREG00000008667/ENSPREG00000008815/ENSPREG00000021316/ENSPREG00000012325/ENSPREG00000017021
## GO:0007275 multicellular organism development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                  ENSPREG00000020203/ENSPREG00000021322/ENSPREG00000011367/ENSPREG00000001369/ENSPREG00000006929/ENSPREG00000007900/ENSPREG00000021725/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000003088/ENSPREG00000006767/ENSPREG00000012582/ENSPREG00000006315/ENSPREG00000000568/ENSPREG00000002117/ENSPREG00000000612/ENSPREG00000002795/ENSPREG00000011913/ENSPREG00000019795/ENSPREG00000013048/ENSPREG00000021144/ENSPREG00000009481/ENSPREG00000018023/ENSPREG00000019494/ENSPREG00000008962/ENSPREG00000016797/ENSPREG00000009349/ENSPREG00000010250/ENSPREG00000011561/ENSPREG00000013766/ENSPREG00000012325
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000001369/ENSPREG00000009674/ENSPREG00000022546
## GO:0030182 neuron differentiation                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                               ENSPREG00000009674/ENSPREG00000014608/ENSPREG00000019835/ENSPREG00000008962
## GO:0016567 protein ubiquitination                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                     ENSPREG00000018477/ENSPREG00000001335/ENSPREG00000016377/ENSPREG00000010792/ENSPREG00000001734/ENSPREG00000020741/ENSPREG00000018515/ENSPREG00000013944/ENSPREG00000009666/ENSPREG00000013726/ENSPREG00000010064/ENSPREG00000004736/ENSPREG00000022808/ENSPREG00000013695/ENSPREG00000005123/ENSPREG00000007331/ENSPREG00000022594/ENSPREG00000013298
## GO:0005634 nucleus                                                                  ENSPREG00000022956/ENSPREG00000011953/ENSPREG00000019319/ENSPREG00000020203/ENSPREG00000012188/ENSPREG00000015471/ENSPREG00000019823/ENSPREG00000011367/ENSPREG00000000100/ENSPREG00000001369/ENSPREG00000016198/ENSPREG00000004628/ENSPREG00000006929/ENSPREG00000005331/ENSPREG00000011568/ENSPREG00000003428/ENSPREG00000018820/ENSPREG00000007900/ENSPREG00000011918/ENSPREG00000021152/ENSPREG00000014413/ENSPREG00000021725/ENSPREG00000020093/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000003088/ENSPREG00000006767/ENSPREG00000002287/ENSPREG00000012582/ENSPREG00000020193/ENSPREG00000001808/ENSPREG00000006315/ENSPREG00000000922/ENSPREG00000005246/ENSPREG00000013067/ENSPREG00000022267/ENSPREG00000009351/ENSPREG00000016347/ENSPREG00000004107/ENSPREG00000001734/ENSPREG00000018881/ENSPREG00000006464/ENSPREG00000000568/ENSPREG00000002117/ENSPREG00000014973/ENSPREG00000009674/ENSPREG00000008235/ENSPREG00000019479/ENSPREG00000012868/ENSPREG00000002795/ENSPREG00000021689/ENSPREG00000022924/ENSPREG00000011913/ENSPREG00000000298/ENSPREG00000022703/ENSPREG00000004976/ENSPREG00000019795/ENSPREG00000000313/ENSPREG00000004425/ENSPREG00000021707/ENSPREG00000013048/ENSPREG00000019472/ENSPREG00000000639/ENSPREG00000010086/ENSPREG00000018023/ENSPREG00000018972/ENSPREG00000007715/ENSPREG00000021553/ENSPREG00000016979/ENSPREG00000003658/ENSPREG00000022723/ENSPREG00000014608/ENSPREG00000004390/ENSPREG00000001387/ENSPREG00000011064/ENSPREG00000001742/ENSPREG00000018730/ENSPREG00000004023/ENSPREG00000006460/ENSPREG00000000443/ENSPREG00000012137/ENSPREG00000005042/ENSPREG00000003440/ENSPREG00000021865/ENSPREG00000004029/ENSPREG00000005028/ENSPREG00000016797/ENSPREG00000010250/ENSPREG00000019031/ENSPREG00000013386/ENSPREG00000017016/ENSPREG00000021088/ENSPREG00000007722/ENSPREG00000013766/ENSPREG00000015491/ENSPREG00000005599/ENSPREG00000008667/ENSPREG00000008815/ENSPREG00000011689/ENSPREG00000020701/ENSPREG00000012325/ENSPREG00000013423/ENSPREG00000021691/ENSPREG00000017021
## GO:0003700 DNA-binding transcription factor activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                 ENSPREG00000020203/ENSPREG00000012188/ENSPREG00000004628/ENSPREG00000007900/ENSPREG00000021725/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000006767/ENSPREG00000000922/ENSPREG00000013067/ENSPREG00000022267/ENSPREG00000009351/ENSPREG00000018881/ENSPREG00000000568/ENSPREG00000009674/ENSPREG00000011913/ENSPREG00000010086/ENSPREG00000021553/ENSPREG00000022723/ENSPREG00000011064/ENSPREG00000010341/ENSPREG00000004029/ENSPREG00000016797/ENSPREG00000013386/ENSPREG00000017016/ENSPREG00000013766/ENSPREG00000008667/ENSPREG00000008815/ENSPREG00000017021
## GO:0061053 somite development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                   ENSPREG00000005012/ENSPREG00000006929/ENSPREG00000019213/ENSPREG00000021266
## GO:0000439 transcription factor TFIIH core complex                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                    ENSPREG00000012137/ENSPREG00000013423
## GO:0003160 endocardium morphogenesis                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                  ENSPREG00000006929/ENSPREG00000008747
## GO:0006384 transcription initiation from RNA polymerase III promoter                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                  ENSPREG00000021756/ENSPREG00000021691
##                                                                                     Count
## GO:0030168 platelet activation                                                          4
## GO:0003677 DNA binding                                                                 68
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific       22
## GO:0006357 regulation of transcription by RNA polymerase II                            26
## GO:0006355 regulation of transcription, DNA-templated                                  51
## GO:0007275 multicellular organism development                                          31
## GO:0001228 DNA-binding transcription activator activity, RNA polymerase II-specific     3
## GO:0030182 neuron differentiation                                                       4
## GO:0016567 protein ubiquitination                                                      18
## GO:0005634 nucleus                                                                    104
## GO:0003700 DNA-binding transcription factor activity                                   29
## GO:0061053 somite development                                                           4
## GO:0000439 transcription factor TFIIH core complex                                      2
## GO:0003160 endocardium morphogenesis                                                    2
## GO:0006384 transcription initiation from RNA polymerase III promoter                    2
c_dn <- enricher(gene = GvL_dn, universe = GvL_bg, minGSSize = 5,  maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_dn,15)
##                                                                                                                                                    ID
## GO:0015245 fatty acid transmembrane transporter activity                                     GO:0015245 fatty acid transmembrane transporter activity
## GO:0001676 long-chain fatty acid metabolic process                                                 GO:0001676 long-chain fatty acid metabolic process
## GO:0004467 long-chain fatty acid-CoA ligase activity                                             GO:0004467 long-chain fatty acid-CoA ligase activity
## GO:0015908 fatty acid transport                                                                                       GO:0015908 fatty acid transport
## GO:0031957 very long-chain fatty acid-CoA ligase activity                                   GO:0031957 very long-chain fatty acid-CoA ligase activity
## GO:0060319 primitive erythrocyte differentiation                                                     GO:0060319 primitive erythrocyte differentiation
## GO:0030424 axon                                                                                                                       GO:0030424 axon
## GO:0005882 intermediate filament                                                                                     GO:0005882 intermediate filament
## GO:0006699 bile acid biosynthetic process                                                                   GO:0006699 bile acid biosynthetic process
## GO:0008630 intrinsic apoptotic signaling pathway in response to DNA damage GO:0008630 intrinsic apoptotic signaling pathway in response to DNA damage
## GO:0035198 miRNA binding                                                                                                     GO:0035198 miRNA binding
## GO:0046580 negative regulation of Ras protein signal transduction                   GO:0046580 negative regulation of Ras protein signal transduction
## GO:0005861 troponin complex                                                                                               GO:0005861 troponin complex
## GO:0005666 RNA polymerase III complex                                                                           GO:0005666 RNA polymerase III complex
## GO:0031076 embryonic camera-type eye development                                                     GO:0031076 embryonic camera-type eye development
##                                                                                                                                           Description
## GO:0015245 fatty acid transmembrane transporter activity                                     GO:0015245 fatty acid transmembrane transporter activity
## GO:0001676 long-chain fatty acid metabolic process                                                 GO:0001676 long-chain fatty acid metabolic process
## GO:0004467 long-chain fatty acid-CoA ligase activity                                             GO:0004467 long-chain fatty acid-CoA ligase activity
## GO:0015908 fatty acid transport                                                                                       GO:0015908 fatty acid transport
## GO:0031957 very long-chain fatty acid-CoA ligase activity                                   GO:0031957 very long-chain fatty acid-CoA ligase activity
## GO:0060319 primitive erythrocyte differentiation                                                     GO:0060319 primitive erythrocyte differentiation
## GO:0030424 axon                                                                                                                       GO:0030424 axon
## GO:0005882 intermediate filament                                                                                     GO:0005882 intermediate filament
## GO:0006699 bile acid biosynthetic process                                                                   GO:0006699 bile acid biosynthetic process
## GO:0008630 intrinsic apoptotic signaling pathway in response to DNA damage GO:0008630 intrinsic apoptotic signaling pathway in response to DNA damage
## GO:0035198 miRNA binding                                                                                                     GO:0035198 miRNA binding
## GO:0046580 negative regulation of Ras protein signal transduction                   GO:0046580 negative regulation of Ras protein signal transduction
## GO:0005861 troponin complex                                                                                               GO:0005861 troponin complex
## GO:0005666 RNA polymerase III complex                                                                           GO:0005666 RNA polymerase III complex
## GO:0031076 embryonic camera-type eye development                                                     GO:0031076 embryonic camera-type eye development
##                                                                            GeneRatio
## GO:0015245 fatty acid transmembrane transporter activity                       3/469
## GO:0001676 long-chain fatty acid metabolic process                             3/469
## GO:0004467 long-chain fatty acid-CoA ligase activity                           3/469
## GO:0015908 fatty acid transport                                                3/469
## GO:0031957 very long-chain fatty acid-CoA ligase activity                      3/469
## GO:0060319 primitive erythrocyte differentiation                               3/469
## GO:0030424 axon                                                                4/469
## GO:0005882 intermediate filament                                               5/469
## GO:0006699 bile acid biosynthetic process                                      2/469
## GO:0008630 intrinsic apoptotic signaling pathway in response to DNA damage     2/469
## GO:0035198 miRNA binding                                                       2/469
## GO:0046580 negative regulation of Ras protein signal transduction              2/469
## GO:0005861 troponin complex                                                    3/469
## GO:0005666 RNA polymerase III complex                                          2/469
## GO:0031076 embryonic camera-type eye development                               2/469
##                                                                             BgRatio
## GO:0015245 fatty acid transmembrane transporter activity                    6/18091
## GO:0001676 long-chain fatty acid metabolic process                          7/18091
## GO:0004467 long-chain fatty acid-CoA ligase activity                        7/18091
## GO:0015908 fatty acid transport                                             7/18091
## GO:0031957 very long-chain fatty acid-CoA ligase activity                   7/18091
## GO:0060319 primitive erythrocyte differentiation                           10/18091
## GO:0030424 axon                                                            29/18091
## GO:0005882 intermediate filament                                           49/18091
## GO:0006699 bile acid biosynthetic process                                   6/18091
## GO:0008630 intrinsic apoptotic signaling pathway in response to DNA damage  6/18091
## GO:0035198 miRNA binding                                                    6/18091
## GO:0046580 negative regulation of Ras protein signal transduction           6/18091
## GO:0005861 troponin complex                                                19/18091
## GO:0005666 RNA polymerase III complex                                       7/18091
## GO:0031076 embryonic camera-type eye development                            7/18091
##                                                                                  pvalue
## GO:0015245 fatty acid transmembrane transporter activity                   0.0003266341
## GO:0001676 long-chain fatty acid metabolic process                         0.0005606072
## GO:0004467 long-chain fatty acid-CoA ligase activity                       0.0005606072
## GO:0015908 fatty acid transport                                            0.0005606072
## GO:0031957 very long-chain fatty acid-CoA ligase activity                  0.0005606072
## GO:0060319 primitive erythrocyte differentiation                           0.0018134911
## GO:0030424 axon                                                            0.0063360450
## GO:0005882 intermediate filament                                           0.0085587464
## GO:0006699 bile acid biosynthetic process                                  0.0093874551
## GO:0008630 intrinsic apoptotic signaling pathway in response to DNA damage 0.0093874551
## GO:0035198 miRNA binding                                                   0.0093874551
## GO:0046580 negative regulation of Ras protein signal transduction          0.0093874551
## GO:0005861 troponin complex                                                0.0123167824
## GO:0005666 RNA polymerase III complex                                      0.0129181942
## GO:0031076 embryonic camera-type eye development                           0.0129181942
##                                                                              p.adjust
## GO:0015245 fatty acid transmembrane transporter activity                   0.07556985
## GO:0001676 long-chain fatty acid metabolic process                         0.07556985
## GO:0004467 long-chain fatty acid-CoA ligase activity                       0.07556985
## GO:0015908 fatty acid transport                                            0.07556985
## GO:0031957 very long-chain fatty acid-CoA ligase activity                  0.07556985
## GO:0060319 primitive erythrocyte differentiation                           0.20371550
## GO:0030424 axon                                                            0.52726206
## GO:0005882 intermediate filament                                           0.52726206
## GO:0006699 bile acid biosynthetic process                                  0.52726206
## GO:0008630 intrinsic apoptotic signaling pathway in response to DNA damage 0.52726206
## GO:0035198 miRNA binding                                                   0.52726206
## GO:0046580 negative regulation of Ras protein signal transduction          0.52726206
## GO:0005861 troponin complex                                                0.55284905
## GO:0005666 RNA polymerase III complex                                      0.55284905
## GO:0031076 embryonic camera-type eye development                           0.55284905
##                                                                                qvalue
## GO:0015245 fatty acid transmembrane transporter activity                   0.07494433
## GO:0001676 long-chain fatty acid metabolic process                         0.07494433
## GO:0004467 long-chain fatty acid-CoA ligase activity                       0.07494433
## GO:0015908 fatty acid transport                                            0.07494433
## GO:0031957 very long-chain fatty acid-CoA ligase activity                  0.07494433
## GO:0060319 primitive erythrocyte differentiation                           0.20202928
## GO:0030424 axon                                                            0.52289772
## GO:0005882 intermediate filament                                           0.52289772
## GO:0006699 bile acid biosynthetic process                                  0.52289772
## GO:0008630 intrinsic apoptotic signaling pathway in response to DNA damage 0.52289772
## GO:0035198 miRNA binding                                                   0.52289772
## GO:0046580 negative regulation of Ras protein signal transduction          0.52289772
## GO:0005861 troponin complex                                                0.54827291
## GO:0005666 RNA polymerase III complex                                      0.54827291
## GO:0031076 embryonic camera-type eye development                           0.54827291
##                                                                                                                                                                    geneID
## GO:0015245 fatty acid transmembrane transporter activity                                                         ENSPREG00000018896/ENSPREG00000000320/ENSPREG00000015498
## GO:0001676 long-chain fatty acid metabolic process                                                               ENSPREG00000018896/ENSPREG00000000320/ENSPREG00000015498
## GO:0004467 long-chain fatty acid-CoA ligase activity                                                             ENSPREG00000018896/ENSPREG00000000320/ENSPREG00000015498
## GO:0015908 fatty acid transport                                                                                  ENSPREG00000018896/ENSPREG00000000320/ENSPREG00000015498
## GO:0031957 very long-chain fatty acid-CoA ligase activity                                                        ENSPREG00000018896/ENSPREG00000000320/ENSPREG00000015498
## GO:0060319 primitive erythrocyte differentiation                                                                 ENSPREG00000001746/ENSPREG00000008016/ENSPREG00000000691
## GO:0030424 axon                                                                               ENSPREG00000012047/ENSPREG00000011648/ENSPREG00000011984/ENSPREG00000001885
## GO:0005882 intermediate filament                                           ENSPREG00000012716/ENSPREG00000002921/ENSPREG00000000456/ENSPREG00000010040/ENSPREG00000001885
## GO:0006699 bile acid biosynthetic process                                                                                           ENSPREG00000018896/ENSPREG00000015498
## GO:0008630 intrinsic apoptotic signaling pathway in response to DNA damage                                                          ENSPREG00000012212/ENSPREG00000010341
## GO:0035198 miRNA binding                                                                                                            ENSPREG00000020727/ENSPREG00000010315
## GO:0046580 negative regulation of Ras protein signal transduction                                                                   ENSPREG00000017857/ENSPREG00000006469
## GO:0005861 troponin complex                                                                                      ENSPREG00000003081/ENSPREG00000018442/ENSPREG00000002040
## GO:0005666 RNA polymerase III complex                                                                                               ENSPREG00000015562/ENSPREG00000007275
## GO:0031076 embryonic camera-type eye development                                                                                    ENSPREG00000008541/ENSPREG00000004106
##                                                                            Count
## GO:0015245 fatty acid transmembrane transporter activity                       3
## GO:0001676 long-chain fatty acid metabolic process                             3
## GO:0004467 long-chain fatty acid-CoA ligase activity                           3
## GO:0015908 fatty acid transport                                                3
## GO:0031957 very long-chain fatty acid-CoA ligase activity                      3
## GO:0060319 primitive erythrocyte differentiation                               3
## GO:0030424 axon                                                                4
## GO:0005882 intermediate filament                                               5
## GO:0006699 bile acid biosynthetic process                                      2
## GO:0008630 intrinsic apoptotic signaling pathway in response to DNA damage     2
## GO:0035198 miRNA binding                                                       2
## GO:0046580 negative regulation of Ras protein signal transduction              2
## GO:0005861 troponin complex                                                    3
## GO:0005666 RNA polymerase III complex                                          2
## GO:0031076 embryonic camera-type eye development                               2
GvLunion <- union(GvL_up,GvL_dn)

c_union <- enricher(gene = GvLunion, universe = GvL_bg, minGSSize = 5,  maxGSSize = 5000, TERM2GENE = mysetsdf, pvalueCutoff = 1, qvalueCutoff = 1)
head(c_union,15)
##                                                                                                                                                                ID
## GO:0015245 fatty acid transmembrane transporter activity                                                 GO:0015245 fatty acid transmembrane transporter activity
## GO:0001676 long-chain fatty acid metabolic process                                                             GO:0001676 long-chain fatty acid metabolic process
## GO:0004467 long-chain fatty acid-CoA ligase activity                                                         GO:0004467 long-chain fatty acid-CoA ligase activity
## GO:0015908 fatty acid transport                                                                                                   GO:0015908 fatty acid transport
## GO:0031957 very long-chain fatty acid-CoA ligase activity                                               GO:0031957 very long-chain fatty acid-CoA ligase activity
## GO:0006699 bile acid biosynthetic process                                                                               GO:0006699 bile acid biosynthetic process
## GO:0030168 platelet activation                                                                                                     GO:0030168 platelet activation
## GO:0047834 D-threo-aldose 1-dehydrogenase activity                                                             GO:0047834 D-threo-aldose 1-dehydrogenase activity
## GO:0021508 floor plate formation                                                                                                 GO:0021508 floor plate formation
## GO:0030182 neuron differentiation                                                                                               GO:0030182 neuron differentiation
## GO:0031076 embryonic camera-type eye development                                                                 GO:0031076 embryonic camera-type eye development
## GO:0055002 striated muscle cell development                                                                           GO:0055002 striated muscle cell development
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0008217 regulation of blood pressure                                                                                   GO:0008217 regulation of blood pressure
## GO:0005515 protein binding                                                                                                             GO:0005515 protein binding
##                                                                                                                                                       Description
## GO:0015245 fatty acid transmembrane transporter activity                                                 GO:0015245 fatty acid transmembrane transporter activity
## GO:0001676 long-chain fatty acid metabolic process                                                             GO:0001676 long-chain fatty acid metabolic process
## GO:0004467 long-chain fatty acid-CoA ligase activity                                                         GO:0004467 long-chain fatty acid-CoA ligase activity
## GO:0015908 fatty acid transport                                                                                                   GO:0015908 fatty acid transport
## GO:0031957 very long-chain fatty acid-CoA ligase activity                                               GO:0031957 very long-chain fatty acid-CoA ligase activity
## GO:0006699 bile acid biosynthetic process                                                                               GO:0006699 bile acid biosynthetic process
## GO:0030168 platelet activation                                                                                                     GO:0030168 platelet activation
## GO:0047834 D-threo-aldose 1-dehydrogenase activity                                                             GO:0047834 D-threo-aldose 1-dehydrogenase activity
## GO:0021508 floor plate formation                                                                                                 GO:0021508 floor plate formation
## GO:0030182 neuron differentiation                                                                                               GO:0030182 neuron differentiation
## GO:0031076 embryonic camera-type eye development                                                                 GO:0031076 embryonic camera-type eye development
## GO:0055002 striated muscle cell development                                                                           GO:0055002 striated muscle cell development
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific
## GO:0008217 regulation of blood pressure                                                                                   GO:0008217 regulation of blood pressure
## GO:0005515 protein binding                                                                                                             GO:0005515 protein binding
##                                                                                  GeneRatio
## GO:0015245 fatty acid transmembrane transporter activity                            5/1157
## GO:0001676 long-chain fatty acid metabolic process                                  5/1157
## GO:0004467 long-chain fatty acid-CoA ligase activity                                5/1157
## GO:0015908 fatty acid transport                                                     5/1157
## GO:0031957 very long-chain fatty acid-CoA ligase activity                           5/1157
## GO:0006699 bile acid biosynthetic process                                           4/1157
## GO:0030168 platelet activation                                                      4/1157
## GO:0047834 D-threo-aldose 1-dehydrogenase activity                                  5/1157
## GO:0021508 floor plate formation                                                    3/1157
## GO:0030182 neuron differentiation                                                   5/1157
## GO:0031076 embryonic camera-type eye development                                    3/1157
## GO:0055002 striated muscle cell development                                         3/1157
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific   27/1157
## GO:0008217 regulation of blood pressure                                             4/1157
## GO:0005515 protein binding                                                        248/1157
##                                                                                     BgRatio
## GO:0015245 fatty acid transmembrane transporter activity                            6/18091
## GO:0001676 long-chain fatty acid metabolic process                                  7/18091
## GO:0004467 long-chain fatty acid-CoA ligase activity                                7/18091
## GO:0015908 fatty acid transport                                                     7/18091
## GO:0031957 very long-chain fatty acid-CoA ligase activity                           7/18091
## GO:0006699 bile acid biosynthetic process                                           6/18091
## GO:0030168 platelet activation                                                      7/18091
## GO:0047834 D-threo-aldose 1-dehydrogenase activity                                 15/18091
## GO:0021508 floor plate formation                                                    6/18091
## GO:0030182 neuron differentiation                                                  20/18091
## GO:0031076 embryonic camera-type eye development                                    7/18091
## GO:0055002 striated muscle cell development                                         7/18091
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific  260/18091
## GO:0008217 regulation of blood pressure                                            14/18091
## GO:0005515 protein binding                                                       3397/18091
##                                                                                        pvalue
## GO:0015245 fatty acid transmembrane transporter activity                         6.029762e-06
## GO:0001676 long-chain fatty acid metabolic process                               1.998571e-05
## GO:0004467 long-chain fatty acid-CoA ligase activity                             1.998571e-05
## GO:0015908 fatty acid transport                                                  1.998571e-05
## GO:0031957 very long-chain fatty acid-CoA ligase activity                        1.998571e-05
## GO:0006699 bile acid biosynthetic process                                        2.249311e-04
## GO:0030168 platelet activation                                                   4.981916e-04
## GO:0047834 D-threo-aldose 1-dehydrogenase activity                               1.854733e-03
## GO:0021508 floor plate formation                                                 4.507354e-03
## GO:0030182 neuron differentiation                                                7.330917e-03
## GO:0031076 embryonic camera-type eye development                                 7.514226e-03
## GO:0055002 striated muscle cell development                                      7.514226e-03
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 8.936766e-03
## GO:0008217 regulation of blood pressure                                          9.927827e-03
## GO:0005515 protein binding                                                       1.007461e-02
##                                                                                     p.adjust
## GO:0015245 fatty acid transmembrane transporter activity                         0.004308918
## GO:0001676 long-chain fatty acid metabolic process                               0.004308918
## GO:0004467 long-chain fatty acid-CoA ligase activity                             0.004308918
## GO:0015908 fatty acid transport                                                  0.004308918
## GO:0031957 very long-chain fatty acid-CoA ligase activity                        0.004308918
## GO:0006699 bile acid biosynthetic process                                        0.040412619
## GO:0030168 platelet activation                                                   0.076721507
## GO:0047834 D-threo-aldose 1-dehydrogenase activity                               0.249925207
## GO:0021508 floor plate formation                                                 0.539880880
## GO:0030182 neuron differentiation                                                0.675027996
## GO:0031076 embryonic camera-type eye development                                 0.675027996
## GO:0055002 striated muscle cell development                                      0.675027996
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.724028667
## GO:0008217 regulation of blood pressure                                          0.724028667
## GO:0005515 protein binding                                                       0.724028667
##                                                                                      qvalue
## GO:0015245 fatty acid transmembrane transporter activity                         0.00430429
## GO:0001676 long-chain fatty acid metabolic process                               0.00430429
## GO:0004467 long-chain fatty acid-CoA ligase activity                             0.00430429
## GO:0015908 fatty acid transport                                                  0.00430429
## GO:0031957 very long-chain fatty acid-CoA ligase activity                        0.00430429
## GO:0006699 bile acid biosynthetic process                                        0.04036921
## GO:0030168 platelet activation                                                   0.07663910
## GO:0047834 D-threo-aldose 1-dehydrogenase activity                               0.24965676
## GO:0021508 floor plate formation                                                 0.53930099
## GO:0030182 neuron differentiation                                                0.67430294
## GO:0031076 embryonic camera-type eye development                                 0.67430294
## GO:0055002 striated muscle cell development                                      0.67430294
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific 0.72325098
## GO:0008217 regulation of blood pressure                                          0.72325098
## GO:0005515 protein binding                                                       0.72325098
##                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                   geneID
## GO:0015245 fatty acid transmembrane transporter activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                  ENSPREG00000015513/ENSPREG00000015526/ENSPREG00000018896/ENSPREG00000000320/ENSPREG00000015498
## GO:0001676 long-chain fatty acid metabolic process                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000015513/ENSPREG00000015526/ENSPREG00000018896/ENSPREG00000000320/ENSPREG00000015498
## GO:0004467 long-chain fatty acid-CoA ligase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                      ENSPREG00000015513/ENSPREG00000015526/ENSPREG00000018896/ENSPREG00000000320/ENSPREG00000015498
## GO:0015908 fatty acid transport                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                           ENSPREG00000015513/ENSPREG00000015526/ENSPREG00000018896/ENSPREG00000000320/ENSPREG00000015498
## GO:0031957 very long-chain fatty acid-CoA ligase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                 ENSPREG00000015513/ENSPREG00000015526/ENSPREG00000018896/ENSPREG00000000320/ENSPREG00000015498
## GO:0006699 bile acid biosynthetic process                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                    ENSPREG00000015513/ENSPREG00000015526/ENSPREG00000018896/ENSPREG00000015498
## GO:0030168 platelet activation                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                               ENSPREG00000017046/ENSPREG00000014506/ENSPREG00000000530/ENSPREG00000002789
## GO:0047834 D-threo-aldose 1-dehydrogenase activity                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000023124/ENSPREG00000017483/ENSPREG00000020382/ENSPREG00000000838/ENSPREG00000000605
## GO:0021508 floor plate formation                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000006929/ENSPREG00000008962/ENSPREG00000004106
## GO:0030182 neuron differentiation                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                         ENSPREG00000009674/ENSPREG00000014608/ENSPREG00000019835/ENSPREG00000008962/ENSPREG00000004106
## GO:0031076 embryonic camera-type eye development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                ENSPREG00000008962/ENSPREG00000008541/ENSPREG00000004106
## GO:0055002 striated muscle cell development                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                     ENSPREG00000021266/ENSPREG00000008962/ENSPREG00000004106
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                        ENSPREG00000020203/ENSPREG00000012188/ENSPREG00000019823/ENSPREG00000011367/ENSPREG00000006929/ENSPREG00000007900/ENSPREG00000021725/ENSPREG00000020334/ENSPREG00000020340/ENSPREG00000006767/ENSPREG00000006315/ENSPREG00000013067/ENSPREG00000000568/ENSPREG00000002117/ENSPREG00000009674/ENSPREG00000002795/ENSPREG00000019795/ENSPREG00000013048/ENSPREG00000018023/ENSPREG00000010250/ENSPREG00000013766/ENSPREG00000012325/ENSPREG00000020178/ENSPREG00000001953/ENSPREG00000021717/ENSPREG00000006479/ENSPREG00000005993
## GO:0008217 regulation of blood pressure                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                                      ENSPREG00000022019/ENSPREG00000003617/ENSPREG00000001051/ENSPREG00000001036
## GO:0005515 protein binding                                                       ENSPREG00000004594/ENSPREG00000011953/ENSPREG00000012251/ENSPREG00000005998/ENSPREG00000012853/ENSPREG00000018477/ENSPREG00000019319/ENSPREG00000021322/ENSPREG00000001335/ENSPREG00000015471/ENSPREG00000017867/ENSPREG00000005048/ENSPREG00000002585/ENSPREG00000012822/ENSPREG00000006498/ENSPREG00000006662/ENSPREG00000009060/ENSPREG00000022512/ENSPREG00000013014/ENSPREG00000006443/ENSPREG00000014506/ENSPREG00000017977/ENSPREG00000012897/ENSPREG00000020661/ENSPREG00000021152/ENSPREG00000001239/ENSPREG00000007778/ENSPREG00000017204/ENSPREG00000002248/ENSPREG00000019970/ENSPREG00000020137/ENSPREG00000001142/ENSPREG00000009748/ENSPREG00000008576/ENSPREG00000016967/ENSPREG00000009420/ENSPREG00000023130/ENSPREG00000021756/ENSPREG00000012860/ENSPREG00000019090/ENSPREG00000004636/ENSPREG00000005315/ENSPREG00000001734/ENSPREG00000018881/ENSPREG00000002194/ENSPREG00000013460/ENSPREG00000017713/ENSPREG00000004055/ENSPREG00000003556/ENSPREG00000014973/ENSPREG00000011222/ENSPREG00000018815/ENSPREG00000021689/ENSPREG00000013339/ENSPREG00000010675/ENSPREG00000015324/ENSPREG00000006112/ENSPREG00000000629/ENSPREG00000019123/ENSPREG00000003610/ENSPREG00000012466/ENSPREG00000020310/ENSPREG00000000313/ENSPREG00000002366/ENSPREG00000013162/ENSPREG00000018168/ENSPREG00000009555/ENSPREG00000010398/ENSPREG00000012620/ENSPREG00000022961/ENSPREG00000018867/ENSPREG00000004777/ENSPREG00000022326/ENSPREG00000022339/ENSPREG00000009493/ENSPREG00000022133/ENSPREG00000019390/ENSPREG00000022366/ENSPREG00000019952/ENSPREG00000021215/ENSPREG00000006634/ENSPREG00000007157/ENSPREG00000016525/ENSPREG00000011896/ENSPREG00000009469/ENSPREG00000003508/ENSPREG00000003290/ENSPREG00000011758/ENSPREG00000000685/ENSPREG00000010125/ENSPREG00000006987/ENSPREG00000021622/ENSPREG00000002476/ENSPREG00000014608/ENSPREG00000001983/ENSPREG00000011064/ENSPREG00000001980/ENSPREG00000008778/ENSPREG00000000341/ENSPREG00000015155/ENSPREG00000020009/ENSPREG00000010341/ENSPREG00000017454/ENSPREG00000012413/ENSPREG00000014822/ENSPREG00000004263/ENSPREG00000008123/ENSPREG00000021865/ENSPREG00000020140/ENSPREG00000022616/ENSPREG00000004029/ENSPREG00000005051/ENSPREG00000019340/ENSPREG00000009666/ENSPREG00000004300/ENSPREG00000015991/ENSPREG00000011159/ENSPREG00000000588/ENSPREG00000010064/ENSPREG00000017657/ENSPREG00000006440/ENSPREG00000004736/ENSPREG00000022808/ENSPREG00000005875/ENSPREG00000000164/ENSPREG00000015245/ENSPREG00000011352/ENSPREG00000007731/ENSPREG00000001779/ENSPREG00000000954/ENSPREG00000014507/ENSPREG00000022767/ENSPREG00000007331/ENSPREG00000021401/ENSPREG00000006028/ENSPREG00000011331/ENSPREG00000015478/ENSPREG00000004312/ENSPREG00000022344/ENSPREG00000009801/ENSPREG00000000217/ENSPREG00000022594/ENSPREG00000018440/ENSPREG00000011036/ENSPREG00000013046/ENSPREG00000018664/ENSPREG00000001224/ENSPREG00000005794/ENSPREG00000003283/ENSPREG00000020701/ENSPREG00000003868/ENSPREG00000016489/ENSPREG00000007238/ENSPREG00000021490/ENSPREG00000022867/ENSPREG00000000312/ENSPREG00000012615/ENSPREG00000012212/ENSPREG00000021620/ENSPREG00000016100/ENSPREG00000022506/ENSPREG00000014625/ENSPREG00000013019/ENSPREG00000018231/ENSPREG00000021017/ENSPREG00000002278/ENSPREG00000019089/ENSPREG00000021380/ENSPREG00000006212/ENSPREG00000012566/ENSPREG00000008369/ENSPREG00000006391/ENSPREG00000006354/ENSPREG00000004354/ENSPREG00000018987/ENSPREG00000017705/ENSPREG00000011094/ENSPREG00000007097/ENSPREG00000020039/ENSPREG00000008541/ENSPREG00000005556/ENSPREG00000020727/ENSPREG00000020745/ENSPREG00000011413/ENSPREG00000000237/ENSPREG00000019866/ENSPREG00000008775/ENSPREG00000008786/ENSPREG00000020410/ENSPREG00000007903/ENSPREG00000019244/ENSPREG00000011271/ENSPREG00000022182/ENSPREG00000005525/ENSPREG00000007539/ENSPREG00000019860/ENSPREG00000010850/ENSPREG00000003222/ENSPREG00000004106/ENSPREG00000020859/ENSPREG00000003143/ENSPREG00000019151/ENSPREG00000012782/ENSPREG00000003150/ENSPREG00000015244/ENSPREG00000008623/ENSPREG00000018444/ENSPREG00000000181/ENSPREG00000018381/ENSPREG00000001415/ENSPREG00000002035/ENSPREG00000010315/ENSPREG00000008224/ENSPREG00000012617/ENSPREG00000013138/ENSPREG00000016663/ENSPREG00000022200/ENSPREG00000000581/ENSPREG00000012133/ENSPREG00000018179/ENSPREG00000004374/ENSPREG00000000926/ENSPREG00000017328/ENSPREG00000022413/ENSPREG00000019505/ENSPREG00000020047/ENSPREG00000017608/ENSPREG00000023057/ENSPREG00000016255/ENSPREG00000012268/ENSPREG00000005211/ENSPREG00000019676/ENSPREG00000014417/ENSPREG00000002384/ENSPREG00000002405/ENSPREG00000007301/ENSPREG00000000191/ENSPREG00000020473/ENSPREG00000017329/ENSPREG00000010511/ENSPREG00000020089/ENSPREG00000004424/ENSPREG00000014739/ENSPREG00000011701/ENSPREG00000007082/ENSPREG00000018883/ENSPREG00000014833/ENSPREG00000010790
##                                                                                  Count
## GO:0015245 fatty acid transmembrane transporter activity                             5
## GO:0001676 long-chain fatty acid metabolic process                                   5
## GO:0004467 long-chain fatty acid-CoA ligase activity                                 5
## GO:0015908 fatty acid transport                                                      5
## GO:0031957 very long-chain fatty acid-CoA ligase activity                            5
## GO:0006699 bile acid biosynthetic process                                            4
## GO:0030168 platelet activation                                                       4
## GO:0047834 D-threo-aldose 1-dehydrogenase activity                                   5
## GO:0021508 floor plate formation                                                     3
## GO:0030182 neuron differentiation                                                    5
## GO:0031076 embryonic camera-type eye development                                     3
## GO:0055002 striated muscle cell development                                          3
## GO:0000981 DNA-binding transcription factor activity, RNA polymerase II-specific    27
## GO:0008217 regulation of blood pressure                                              4
## GO:0005515 protein binding                                                         248

Session information

For reproducibility

sessionInfo()
## R version 4.1.1 (2021-08-10)
## Platform: x86_64-pc-linux-gnu (64-bit)
## Running under: Ubuntu 20.04.3 LTS
## 
## Matrix products: default
## BLAS:   /usr/lib/x86_64-linux-gnu/blas/libblas.so.3.9.0
## LAPACK: /usr/lib/x86_64-linux-gnu/lapack/liblapack.so.3.9.0
## 
## locale:
##  [1] LC_CTYPE=en_AU.UTF-8       LC_NUMERIC=C              
##  [3] LC_TIME=en_AU.UTF-8        LC_COLLATE=en_AU.UTF-8    
##  [5] LC_MONETARY=en_AU.UTF-8    LC_MESSAGES=en_AU.UTF-8   
##  [7] LC_PAPER=en_AU.UTF-8       LC_NAME=C                 
##  [9] LC_ADDRESS=C               LC_TELEPHONE=C            
## [11] LC_MEASUREMENT=en_AU.UTF-8 LC_IDENTIFICATION=C       
## 
## attached base packages:
## [1] stats4    parallel  stats     graphics  grDevices utils     datasets 
## [8] methods   base     
## 
## other attached packages:
##  [1] eulerr_6.1.1                clusterProfiler_4.0.5      
##  [3] DESeq2_1.32.0               SummarizedExperiment_1.22.0
##  [5] Biobase_2.52.0              MatrixGenerics_1.4.3       
##  [7] matrixStats_0.60.1          getDEE2_1.2.0              
##  [9] mitch_1.4.1                 seqinr_4.2-8               
## [11] gplots_3.1.1                methylKit_1.18.0           
## [13] limma_3.48.3                GenomicRanges_1.44.0       
## [15] GenomeInfoDb_1.28.4         IRanges_2.26.0             
## [17] S4Vectors_0.30.0            BiocGenerics_0.38.0        
## [19] RColorBrewer_1.1-2          dplyr_1.0.7                
## [21] kableExtra_1.3.4            reshape2_1.4.4             
## [23] R.utils_2.10.1              R.oo_1.24.0                
## [25] R.methodsS3_1.8.1          
## 
## loaded via a namespace (and not attached):
##   [1] utf8_1.2.2               tidyselect_1.1.1         RSQLite_2.2.8           
##   [4] AnnotationDbi_1.54.1     htmlwidgets_1.5.4        grid_4.1.1              
##   [7] BiocParallel_1.26.2      scatterpie_0.1.7         munsell_0.5.0           
##  [10] colorspace_2.0-2         GOSemSim_2.18.1          knitr_1.34              
##  [13] rstudioapi_0.13          fastseg_1.38.0           DOSE_3.18.2             
##  [16] bbmle_1.0.24             GenomeInfoDbData_1.2.6   polyclip_1.10-0         
##  [19] bit64_4.0.5              farver_2.1.0             downloader_0.4          
##  [22] coda_0.19-4              vctrs_0.3.8              treeio_1.16.2           
##  [25] generics_0.1.0           xfun_0.26                R6_2.5.1                
##  [28] graphlayouts_0.7.1       locfit_1.5-9.4           bitops_1.0-7            
##  [31] cachem_1.0.6             reshape_0.8.8            fgsea_1.18.0            
##  [34] gridGraphics_0.5-1       DelayedArray_0.18.0      assertthat_0.2.1        
##  [37] promises_1.2.0.1         BiocIO_1.2.0             scales_1.1.1            
##  [40] ggraph_2.0.5             enrichplot_1.12.2        beeswarm_0.4.0          
##  [43] gtable_0.3.0             tidygraph_1.2.0          rlang_0.4.11            
##  [46] genefilter_1.74.0        systemfonts_1.0.2        splines_4.1.1           
##  [49] rtracklayer_1.52.1       lazyeval_0.2.2           htm2txt_2.1.1           
##  [52] yaml_2.2.1               httpuv_1.6.3             qvalue_2.24.0           
##  [55] tools_4.1.1              ggplotify_0.1.0          ggplot2_3.3.5           
##  [58] ellipsis_0.3.2           jquerylib_0.1.4          Rcpp_1.0.7              
##  [61] plyr_1.8.6               zlibbioc_1.38.0          purrr_0.3.4             
##  [64] RCurl_1.98-1.4           viridis_0.6.1            cowplot_1.1.1           
##  [67] ggrepel_0.9.1            magrittr_2.0.1           data.table_1.14.0       
##  [70] DO.db_2.9                mvtnorm_1.1-2            patchwork_1.1.1         
##  [73] mime_0.11                evaluate_0.14            xtable_1.8-4            
##  [76] XML_3.99-0.7             emdbook_1.3.12           mclust_5.4.7            
##  [79] gridExtra_2.3            compiler_4.1.1           bdsmatrix_1.3-4         
##  [82] tibble_3.1.4             KernSmooth_2.23-20       crayon_1.4.1            
##  [85] shadowtext_0.0.8         htmltools_0.5.2          ggfun_0.0.3             
##  [88] later_1.3.0              tidyr_1.1.3              geneplotter_1.70.0      
##  [91] aplot_0.1.0              DBI_1.1.1                tweenr_1.0.2            
##  [94] MASS_7.3-54              Matrix_1.3-4             ade4_1.7-18             
##  [97] igraph_1.2.6             pkgconfig_2.0.3          GenomicAlignments_1.28.0
## [100] numDeriv_2016.8-1.1      xml2_1.3.2               ggtree_3.0.4            
## [103] svglite_2.0.0            annotate_1.70.0          bslib_0.3.0             
## [106] webshot_0.5.2            XVector_0.32.0           rvest_1.0.1             
## [109] yulab.utils_0.0.2        stringr_1.4.0            digest_0.6.27           
## [112] Biostrings_2.60.2        rmarkdown_2.11           fastmatch_1.1-3         
## [115] tidytree_0.3.5           restfulr_0.0.13          shiny_1.6.0             
## [118] Rsamtools_2.8.0          gtools_3.9.2             rjson_0.2.20            
## [121] lifecycle_1.0.0          nlme_3.1-153             jsonlite_1.7.2          
## [124] echarts4r_0.4.1          viridisLite_0.4.0        fansi_0.5.0             
## [127] pillar_1.6.2             lattice_0.20-45          GGally_2.1.2            
## [130] KEGGREST_1.32.0          fastmap_1.1.0            httr_1.4.2              
## [133] survival_3.2-13          GO.db_3.13.0             glue_1.4.2              
## [136] png_0.1-7                bit_4.0.4                ggforce_0.3.3           
## [139] stringi_1.7.4            sass_0.4.0               blob_1.2.2              
## [142] caTools_1.18.2           memoise_2.0.0            ape_5.5