Last updated: 2019-03-07

Checks: 6 0

Knit directory: queen-pheromone-RNAseq/

This reproducible R Markdown analysis was created with workflowr (version 1.2.0). The Report tab describes the reproducibility checks that were applied when the results were created. The Past versions tab lists the development history.


Great! Since the R Markdown file has been committed to the Git repository, you know the exact version of the code that produced these results.

Great job! The global environment was empty. Objects defined in the global environment can affect the analysis in your R Markdown file in unknown ways. For reproduciblity it’s best to always run the code in an empty environment.

The command set.seed(20190307) was run prior to running the code in the R Markdown file. Setting a seed ensures that any results that rely on randomness, e.g. subsampling or permutations, are reproducible.

Great job! Recording the operating system, R version, and package versions is critical for reproducibility.

Nice! There were no cached chunks for this analysis, so you can be confident that you successfully produced the results during this run.

Great! You are using Git for version control. Tracking code development and connecting the code version to the results is critical for reproducibility. The version displayed above was the version of the Git repository at the time these results were generated.

Note that you need to be careful to ensure that all relevant files for the analysis have been committed to Git prior to generating the results (you can use wflow_publish or wflow_git_commit). workflowr only checks the R Markdown file, but you know if there are other scripts or data files that it depends on. Below is the status of the Git repository when the results were generated:


Ignored files:
    Ignored:    .DS_Store
    Ignored:    .Rhistory
    Ignored:    .Rproj.user/
    Ignored:    analysis/.DS_Store
    Ignored:    bioinformatics_scripts/data/
    Ignored:    bioinformatics_scripts/ref/
    Ignored:    data/.DS_Store
    Ignored:    data/apis_gene_comparisons/.DS_Store
    Ignored:    data/apis_gene_comparisons/wojciechowski_histone_data/.DS_Store
    Ignored:    data/apis_gene_comparisons/wojciechowski_histone_data/GSE110640_RAW/.DS_Store
    Ignored:    data/apis_gene_comparisons/wojciechowski_histone_data/GSE110641_RAW/.DS_Store
    Ignored:    data/component spreadsheets of queen_pheromone.db/.DS_Store
    Ignored:    docs/figure/pdf_supplementary_material.Rmd/
    Ignored:    figures/
    Ignored:    manuscript/
    Ignored:    supplement/

Unstaged changes:
    Deleted:    bioinformatics_scripts/data
    Deleted:    bioinformatics_scripts/ref

Note that any generated files, e.g. HTML, png, CSS, etc., are not included in this status report because it is ok for generated content to have uncommitted changes.


These are the previous versions of the R Markdown and HTML files. If you’ve configured a remote Git repository (see ?wflow_git_remote), click on the hyperlinks in the table below to view them.

File Version Author Date Message
html 7d083c0 lukeholman 2019-03-07 new theme
html d5a6a73 lukeholman 2019-03-07 Build site.
html f260a62 Luke Holman 2019-03-07 Build site.
Rmd 934cda8 Luke Holman 2019-03-07 First commit of new website structure

This document was written in R Markdown, and translated into html using the R package knitr. Press the buttons labelled Code to show or hide the R code used to produce each table, plot or statistical result. You can also select Show all code at the top of the page.

Load R libraries (install first from CRAN or Bioconductor)

library(WGCNA) # Gene networks - needs 'impute' dependency: source("https://bioconductor.org/biocLite.R"); biocLite("impute")
library(RSQLite) # Access SQLite databases
library(reshape2) # data tidying (melt)
library(dplyr) # data tidying
library(tidyr) # data tidying
library(purrr) # manipulate lists
library(stringr) # string manipulation
library(ggplot2) # for plots
library(ggrepel) # for plots
library(ggdendro) # for plots
library(gridExtra) # for plots
library(grid) # for plots
library(RColorBrewer) # for plots
library(ggjoy) # for plots
library(gplots) # Venn diagram
library(ecodist) # for nmds
library(MuMIn) # for model comparison
library(sva) # for ComBat function; install via source("https://bioconductor.org/biocLite.R"); biocLite("sva")
library(pander) # for nice tables
library(kableExtra) # For scrollable tables
library(clusterProfiler) # for enrichment tests; source("https://bioconductor.org/biocLite.R"); biocLite("clusterProfiler") 
library(fgsea) # for enrichment tests; source("https://bioconductor.org/biocLite.R"); biocLite("fgsea") 
select <- dplyr::select
filter <- dplyr::filter
rename <- dplyr::rename

kable.table <- function(df) {
  kable(df, "html") %>%
  kable_styling() %>%
  scroll_box(height = "300px")
}

# Open database connections (Sasha uses SQL, Luke prefers dplyr)
db <- dbConnect(SQLite(), dbname="data/queen_pheromone.db")
my_db <- src_sqlite("data/queen_pheromone.db")

# These 4 samples should NOT be used (See below). They were also removed in all non-R analyses (e.g. differential gene expression analyses using EBseq)
bad.samples <- c("lf1", "ln1", "ln12", "lf12")

First let’s check for and remove strongly outlying samples

  # Define a function to get gene expression data for a given set of orthologous genes. We define orthologous genes as those that are each other's reciprocal best BLAST. The bad.samples argument can be used to remove some named samples. By default this function logs the expression data (using log10). It returns a list with two elements: the first element is a matrix of expression data (rows = samples, cols = genes), and the second is a data frame giving the species-specific names of the orthologous genes
make.OGGs <- function(species, bad.samples = NULL, log.data = T){
  
  # set up forward mappings, e.g. "am2bt", "am2lf", "am2ln"
  forward.mappings <- paste(species[1], "2", species[2:length(species)], sep = "")
  # and reverse mappings, e.g. "bt2am", "lf2am", "ln2am"
  backward.mappings <- paste(species[2:length(species)], "2", species[1], sep = "")
  items <- list() # declare empty list

  for(i in 1:length(forward.mappings)){
    
    # make a table with 3 columns: first column has species 1 gene,
    # second column has species 2 gene in forward mapping,
    # third column has species 2 gene in reverse mapping (this can be NA, or different to col 2)
    # we want the rows where cols 2 and 3 are the same, indicating reciprocity in the BLAST
    focal <- left_join(
      tbl(my_db, forward.mappings[i]) %>% 
        dplyr::select(-evalue), # get the two mappings and 
      tbl(my_db, backward.mappings[i]) %>% 
        dplyr::select(-evalue), # merge by species 1 column
      by = species[1]
    ) %>% 
      collect(n=Inf) %>% as.data.frame  # collect it all and convert to df
    
    # Get the RBB rows, and keep the two relevant columns
    focal <- focal[!is.na(focal[,3]), ]
    items[[i]] <- focal[focal[,2] == focal[,3], 1:2] 
  }
  rbbs <- items[[1]] # If 3 or 4 species, successively merge the results
  if(length(items) > 1) rbbs <- left_join(rbbs, items[[2]], by = species[1])
  if(length(items) > 2) rbbs <- left_join(rbbs, items[[3]], by = species[1])
  
  # Throw out species1 genes that do not have a RBB in all species
  rbbs <- rbbs[complete.cases(rbbs), ]
  names(rbbs) <- gsub("[.]x", "", names(rbbs)) # tidy the row and column names
  rownames(rbbs) <- NULL

  # Make sure the columns are ordered as in 'species'
  rbbs <- rbbs[, match(names(rbbs), species)]

  # We know have a list of the names of all the ortholgous genes in each species
  # Now we use these names to look up the gene expression data for each ortholog
  expression.tables <- paste("rsem_", species, sep = "")
  
  for(i in 1:length(species)){
    focal.expression <- tbl(my_db, expression.tables[i]) %>% 
      collect(n=Inf) %>% as.data.frame()
    names(focal.expression)[names(focal.expression) == "gene"] <- species[i]
    rbbs <- left_join(rbbs, focal.expression, by = species[i])
  }
  gene.name.mappings <- rbbs[, names(rbbs) %in% species] # save gene name mappings in separate DF
  
  rownames(rbbs) <- rbbs[,1] # Use the gene names for species 1 as row names
  rbbs <- rbbs[, !(names(rbbs) %in% species)] # remove gene name columns 
  rbbs <- t(as.matrix(rbbs))

  if(log.data) rbbs <- log10(1 + rbbs)
  if(!is.null(bad.samples)) rbbs <- rbbs[!(rownames(rbbs) %in% bad.samples), ]
  
  # Discard genes where NAs appear
  gene.name.mappings <- gene.name.mappings[!(is.na(colSums(rbbs))), ]
  rbbs <- rbbs[, !(is.na(colSums(rbbs)))]

  # discard genes where expression is zero for all samples in 1 or more species
  spp <- str_replace_all(rownames(rbbs), "[:digit:]", "")
  to.keep <- rep(TRUE, ncol(rbbs))
  for(i in 1:ncol(rbbs)){
   if(min(as.numeric(tapply(rbbs[,i], spp, sum))) == 0) to.keep[i] <- FALSE
 }
rbbs <- rbbs[, to.keep]
gene.name.mappings <- gene.name.mappings[to.keep, ]

  list(tpm = rbbs, gene.mappings = gene.name.mappings)
}

4 of the Lasius samples are highly different to all of the rest

Closer inspection reveals that they have zeros for many of the transcripts, so perhaps they had low abundance libraries.

set.seed(1) # nmds involves random numbers, so make this plot reproducible
expression.data <- make.OGGs(c("am", "bt", "ln", "lf"))[[1]]
treatments <- tbl(my_db, "treatments") %>% as.data.frame()

shhh <- capture.output(nmds.output <- dist(expression.data) %>% nmds())
fig_S1 <- data.frame(id = rownames(expression.data), nmds.output$conf[[length(nmds.output$conf)]], stringsAsFactors = F) %>%
  left_join(treatments, by = "id") %>% 
  rename(Species = species, Treatment = treatment) %>%
  ggplot(aes(X1,X2, shape = Species)) + 
  geom_point(aes(colour = Treatment)) + 
  geom_text_repel(aes(label = id), size=3.6) + 
  xlab("NMDS 1") + ylab("NMDS 2")

saveRDS(fig_S1, file = "supplement/fig_S1.rds")
fig_S1

Version Author Date
f260a62 Luke Holman 2019-03-07



Figure S1: After reducing the transcriptome data to two axes using non-metric multidimensional scaling, four Lasius samples were clear outliers.

set.seed(1) # nmds involves random numbers, so make this plot reproducible
expression.data <- make.OGGs(c("am", "bt", "ln", "lf"), bad.samples = bad.samples)[[1]]

shhh <- capture.output(nmds.output <- dist(expression.data) %>% nmds())
fig_S2 <- data.frame(id = rownames(expression.data), 
           nmds.output$conf[[length(nmds.output$conf)]], 
           stringsAsFactors = F) %>%
  left_join(treatments, by = "id") %>%
  rename(Species = species, Treatment = treatment) %>% 
  ggplot(aes(X1,X2)) + 
  geom_point(aes(shape = Species, colour = Treatment)) + 
  geom_text_repel(aes(label = id), size=3.6) + 
  xlab("NMDS 1") + ylab("NMDS 2")

saveRDS(fig_S2, file = "supplement/fig_S2.rds")
fig_S2

Version Author Date
f260a62 Luke Holman 2019-03-07



Figure S2: With the four problematic samples removed, the samples cluster according to species with no obvious outliers.

Table of sample sizes

Table S1: Number of sequencing libraries for each combination of species and treatment, after removing the four problematic libraries. Each library was prepared from a pool containing equal amounts of cDNA from five individual workers, taken from the same colony.

sample.size.table <- treatments[treatments$id %in% rownames(expression.data),] %>% 
  group_by(species, treatment) %>% 
  summarise(n = n()) %>% as.data.frame()
names(sample.size.table) <- c("Species", "Treatment", "Number of RNAseq libraries")

saveRDS(sample.size.table, file = "supplement/tab_S1.rds")
sample.size.table %>% pander()
Species Treatment Number of RNAseq libraries
am Control 3
am QP 3
bt Control 5
bt QP 5
lf Control 7
lf QP 6
ln Control 5
ln QP 5

Lists of statistically significant differentially expressed genes

Click the tabs to see the gene lists for each of the four species.

apis.de <- suppressMessages(tbl(my_db, "ebseq_padj_gene_am") %>% 
  dplyr::select(gene, PostFC) %>% 
    left_join(tbl(my_db, "bee_names")) %>% 
    collect() %>% 
  mutate(PostFC = round(log2(PostFC), 3)) %>% 
    dplyr::select(gene, name, PostFC) %>% 
    rename(Gene=gene, Name=name, Log2_FC = PostFC) %>% 
    arrange(-abs(Log2_FC))) %>% as.data.frame()

bombus.de <- suppressMessages(tbl(my_db, "ebseq_padj_gene_bt") %>% 
  dplyr::select(gene, PostFC) %>% 
    left_join(tbl(my_db, "bt2am") %>% rename(gene=bt)) %>% 
    left_join(tbl(my_db, "bee_names") %>% rename(am=gene)) %>% 
    collect() %>%
   mutate(PostFC = round(log2(PostFC), 3), name = replace(name, is.na(name), " "), 
          am = replace(am, is.na(am), " ")) %>% 
  dplyr::select(gene, am, name, PostFC) %>% 
    rename(Gene=gene, Apis_BLAST=am, Name=name, Log2_FC = PostFC) %>% 
    arrange(-abs(Log2_FC))) %>% as.data.frame()

flavus.de <- suppressMessages(tbl(my_db, "ebseq_padj_gene_lf") %>% 
  dplyr::select(gene, PostFC) %>% 
    left_join(tbl(my_db, "lf2am") %>% rename(gene=lf)) %>% 
    left_join(tbl(my_db, "bee_names") %>% rename(am=gene)) %>% 
    collect() %>%
   mutate(PostFC = round(log2(PostFC), 3), name = replace(name, is.na(name), " "), 
          am = replace(am, is.na(am), " ")) %>% 
  dplyr::select(gene, am, name, PostFC) %>% 
    rename(Gene=gene, Apis_BLAST=am, Name=name, Log2_FC = PostFC) %>%
    arrange(-abs(Log2_FC))) %>% as.data.frame()

niger.de <- suppressMessages(tbl(my_db, "ebseq_padj_gene_ln") %>% 
  dplyr::select(gene, PostFC) %>% 
    left_join(tbl(my_db, "ln2am") %>% rename(gene=ln)) %>% 
    left_join(tbl(my_db, "bee_names") %>% rename(am=gene)) %>% 
    collect() %>%
   mutate(PostFC = round(log2(PostFC), 3), name = replace(name, is.na(name), " "), 
          am = replace(am, is.na(am), " ")) %>% 
  dplyr::select(gene, am, name, PostFC) %>% 
    rename(Gene=gene, Apis_BLAST=am, Name=name, Log2_FC = PostFC) %>% 
    arrange(-abs(Log2_FC))) %>% as.data.frame()

names(apis.de) <- gsub("_", " ", names(apis.de))
names(bombus.de) <- gsub("_", " ", names(bombus.de))
names(flavus.de) <- gsub("_", " ", names(flavus.de))
names(niger.de) <- gsub("_", " ", names(niger.de))

Apis mellifera

Table S2: List of the 322 significantly differentially expressed genes (EBseq; FDR-corrected posterior probability of differential expression p < 0.05) in Apis mellifera, listed in order of fold change in gene expression on a Log\(_2\) scale. Positive fold change values indicate higher expression in the control, while negative values indicate higher expression in the queen pheromone treatment.

saveRDS(apis.de, file = "supplement/tab_S2.rds")
kable.table(apis.de)
Gene Name Log2 FC
GB55204 Major royal jelly protein 3 6.480
GB51373 bypass of stop codon protein 1-like 5.385
GB50604 uncharacterized protein LOC724113 3.775
102655911 uncharacterized protein LOC102655911 -3.376
GB49819 branched-chain-amino-acid aminotransferase, cytosolic-like 2.657
102656917 uncharacterized LOC102656917, transcript variant X1 2.609
GB54417 dehydrogenase/reductase SDR family member 11-like isoform X1 2.242
GB45565 chymotrypsin-2 2.052
GB53886 protein G12-like isoform X4 1.983
100576536 uncharacterized protein LOC100576536 1.945
GB41540 venom carboxylesterase-6-like -1.721
GB54690 uncharacterized protein LOC408547 -1.583
GB54150 uncharacterized protein LOC408462 -1.560
GB43639 uncharacterized protein LOC100577506 isoform X1 -1.557
GB49548 serine/threonine-protein phosphatase 2B catalytic subunit 3-like isoform X11 -1.455
GB49878 probable cytochrome P450 6a14 isoformX1 1.393
GB53414 serine/threonine-protein kinase ICK-like isoform X2 1.357
102654781 protein G12-like 1.324
102656058 uncharacterized protein PF11_0213-like -1.311
GB53957 U6 snRNA-associated Sm-like protein LSm1-like 1.276
GB50413 protein TBRG4-like isoform X1 -1.261
102653931 uncharacterized LOC102653931, transcript variant X2 -1.258
GB53876 interaptin-like -1.209
GB42705 protein archease-like 1.184
101664701 PI-PLC X domain-containing protein 1-like isoform X1 1.143
GB42523 uncharacterized LOC100577781, transcript variant X2 -1.130
102654405 protein G12-like 1.115
100578075 uncharacterized LOC100578075 -1.110
GB52251 multifunctional protein ADE2, transcript variant X2 1.088
GB40764 uncharacterized protein LOC414021 isoform X7 -1.086
GB55648 Down syndrome cell adhesion molecule-like protein Dscam2-like isoform X7 -1.084
726446 uncharacterized protein LOC726446 -1.063
GB54467 probable G-protein coupled receptor 52 isoform 1 -1.060
GB46985 60S ribosomal protein L12 isoform X1 1.045
GB55191 uncharacterized protein LOC100576289 -1.045
GB54890 kynurenine 3-monooxygenase isoform X2 1.016
GB55640 retinol dehydrogenase 12-like -1.006
724802 protein Asterix-like 0.996
GB40010 titin-like isoform X2 -0.967
102654949 uncharacterized protein LOC102654949 0.967
GB43234 histone deacetylase 5 isoform X8 -0.965
GB52266 furin-like protease 2-like -0.927
GB41706 ice-structuring glycoprotein-like -0.926
GB42673 retinol dehydrogenase 10-A-like isoform X4 0.923
GB55030 uncharacterized protein LOC725074 0.921
551123 RNA-binding protein Musashi homolog Rbp6-like isoform X1 -0.920
409728 40S ribosomal protein S5 isoform X1 0.917
GB45028 venom dipeptidyl peptidase 4 -0.898
GB53422 ufm1-specific protease 1-like isoform X2 0.892
GB48933 methenyltetrahydrofolate synthase domain-containing protein-like -0.876
GB53077 cysteine-rich protein 1-like 0.871
GB41301 annexin-B9-like 0.862
GB51748 dentin sialophosphoprotein -0.861
102654594 WD repeat-containing protein 18-like 0.852
GB50356 60S acidic ribosomal protein P2 0.837
GB44091 LOW QUALITY PROTEIN: uncharacterized protein LOC408779 -0.836
GB41151 protein MNN4-like -0.834
409202 ribosomal protein S9, transcript variant X2 0.834
GB44340 small ubiquitin-related modifier 3 isoform 1 0.833
GB49173 4-aminobutyrate aminotransferase, mitochondrial-like isoform X2 -0.826
GB40769 dehydrogenase/reductase SDR family member 11-like 0.823
GB54243 LOW QUALITY PROTEIN: carbonyl reductase [NADPH] 1-like 0.819
724531 40S ribosomal protein S28-like 0.812
GB51744 uncharacterized protein LOC724439 0.811
GB51947 uncharacterized protein LOC724835 isoform X2 -0.807
GB40875 60S ribosomal protein L10 isoform X1 0.806
102655694 glutathione S-transferase-like 0.803
GB55827 40S ribosomal protein S21-like isoform X1 0.801
102654426 60S ribosomal protein L18-like 0.801
GB49988 SRR1-like protein-like isoform X2 -0.800
GB55963 uncharacterized protein LOC725224 isoform X1 -0.797
GB50867 cell differentiation protein RCD1 homolog isoform X2 0.794
GB43256 ATP-binding cassette sub-family D member 1-like 0.792
GB41211 ATP-binding cassette sub-family E member 1 0.787
GB52314 gamma-tubulin complex component 4 -0.785
102654251 uncharacterized protein LOC102654251 -0.782
726860 cytochrome b5-like isoform 1 0.778
GB46039 tubulin alpha-1 chain-like 0.773
GB53358 protein transport protein Sec61 subunit gamma-like isoform X3 0.768
GB48699 60S ribosomal protein L11-like 0.767
GB44311 actin related protein 1 0.762
102655603 transmembrane emp24 domain-containing protein 7-like 0.762
GB49170 40S ribosomal protein S15Aa-like isoform 1 0.758
GB47736 alkyldihydroxyacetonephosphate synthase-like 0.753
GB49013 RNA-binding protein 8A 0.752
724485 probable small nuclear ribonucleoprotein E-like 0.749
GB53000 ubiquitin-60S ribosomal protein L40 isoform 2 0.749
725936 titin-like -0.748
GB50158 60S ribosomal protein L4 isoform 1 0.748
GB52432 KN motif and ankyrin repeat domain-containing protein 3-like isoform X3 -0.746
724757 histone H4-like 0.745
GB53219 40S ribosomal protein S17 0.742
100577623 putative uncharacterized protein DDB_G0282133-like isoform X2 -0.742
GB51038 60S ribosomal protein L23 0.739
GB40284 cytochrome P450 6a2 0.737
GB50709 40S ribosomal protein S19a 0.735
GB50977 probable tubulin polyglutamylase TTLL2-like -0.734
GB42537 40S ribosomal protein S15 0.734
GB42467 phospholipase B1, membrane-associated-like isoform X2 0.733
GB41886 protein transport protein Sec61 subunit alpha isoform 2 0.729
GB51201 40S ribosomal protein S12 isoform X1 0.724
GB55183 ankyrin repeat domain-containing protein SOWAHB-like isoform X5 -0.724
GB54814 60S ribosomal protein L31 isoform 1 0.721
GB49159 probable nuclear transport factor 2-like isoform 3 0.717
GB52512 60S ribosomal protein L28 0.714
GB41142 probable dolichyl pyrophosphate Glc1Man9GlcNAc2 alpha-1,3-glucosyltransferase-like isoform X2 0.712
GB51359 60S ribosomal protein L27a isoform X1 0.710
GB50519 transmembrane emp24 domain-containing protein eca-like 0.710
GB47638 ER membrane protein complex subunit 3-like 0.705
GB51046 probable signal peptidase complex subunit 2-like 0.701
GB54973 selT-like protein-like isoform 1 0.693
GB44661 intracellular protein transport protein USO1 isoform X9 -0.691
GB53953 mitochondrial coenzyme A transporter SLC25A42-like isoformX1 -0.688
GB48289 uncharacterized protein LOC726292 isoform X1 0.688
GB47808 DEP domain-containing protein 5 isoform X4 -0.685
GB45937 intracellular protein transport protein USO1 isoform X2 -0.684
GB53750 UPF0454 protein C12orf49 homolog isoform X2 0.682
GB50455 ubiquitin-conjugating enzyme E2-17 kDa-like 0.676
GB42356 arginine-glutamic acid dipeptide repeats protein-like -0.675
GB51072 40S ribosomal protein S4-like isoform 1 0.669
GB55268 43 kDa receptor-associated protein of the synapse homolog isoform X3 -0.669
GB43086 uncharacterized protein LOC726486 0.668
102655259 5-methylcytosine rRNA methyltransferase NSUN4-like isoform X1 -0.667
GB55639 40S ribosomal protein S3 0.666
GB41159 bifunctional dihydrofolate reductase-thymidylate synthase 0.665
GB42354 ATP-dependent Clp protease ATP-binding subunit clpX-like, mitochondrial-like isoform X4 -0.663
GB42696 60S ribosomal protein L35a isoform X3 0.656
GB42088 40S ribosomal protein S29-like isoform X2 0.652
GB53948 uncharacterized protein LOC410057 isoform X1 -0.651
GB47553 electron transfer flavoprotein subunit alpha, mitochondrial-like isoform 1 0.650
100577163 slit homolog 2 protein-like 0.650
GB52627 protein pigeon-like -0.650
GB54020 apolipoprotein D-like 0.650
102655440 uncharacterized protein LOC102655440 -0.649
GB51009 T-complex protein 1 subunit delta-like isoform 1 0.649
GB49583 40S ribosomal protein S14 0.647
GB41039 60S ribosomal protein L17 isoform 1 0.647
GB46627 paraplegin-like -0.645
GB54174 E3 ubiquitin-protein ligase RING1 isoform 1 0.643
GB41240 aquaporin AQPAn.G-like isoform X3 -0.641
GB51440 proteoglycan 4-like -0.641
GB45433 small ribonucleoprotein particle protein B 0.638
GB51603 peptidyl-alpha-hydroxyglycine alpha-amidating lyase 1-like isoform X5 -0.638
100191002 ribosomal protein L41 0.638
GB43989 serine-threonine kinase receptor-associated protein-like 0.637
GB53799 proteasome subunit alpha type-2 0.636
GB43141 uncharacterized protein LOC413428 -0.636
GB44999 chascon-like -0.633
GB49154 bcl-2-related ovarian killer protein homolog A 0.632
GB50189 epsilon-sarcoglycan -0.630
GB41150 40S ribosomal protein S2 isoform 2 0.628
GB50917 60S acidic ribosomal protein P1 0.627
GB48201 39S ribosomal protein L53, mitochondrial 0.627
GB44575 ankyrin repeat and zinc finger domain-containing protein 1-like isoform X1 -0.626
GB46776 40S ribosomal protein S11 isoform X1 0.624
GB49789 28S ribosomal protein S29, mitochondrial isoformX1 -0.621
GB46750 40S ribosomal protein S16 0.620
GB44749 60S ribosomal protein L9 0.618
GB44931 evolutionarily conserved signaling intermediate in Toll pathway, mitochondrial-like -0.613
GB46845 60S ribosomal protein L37a 0.611
GB43379 membrane-bound transcription factor site-2 protease-like 0.609
GB45369 receptor of activated protein kinase C 1, transcript variant X3 0.606
GB52698 synaptobrevin-like isoformX1 0.605
724829 immediate early response 3-interacting protein 1-like isoform X1 0.605
GB49536 gamma-secretase subunit Aph-1 0.604
GB55628 probable RNA-binding protein EIF1AD-like isoform X1 0.603
GB50832 THO complex subunit 4-like 0.602
GB50929 mitochondrial import receptor subunit TOM40 homolog 1-like isoform 1 0.601
GB51065 40S ribosomal protein S10-like isoform 1 0.601
GB54984 chromatin complexes subunit BAP18-like isoform X1 0.600
GB43180 minor histocompatibility antigen H13-like 0.597
GB49365 gamma-secretase subunit pen-2 isoform 1 0.595
GB51543 60S ribosomal protein L13a isoform 2 0.594
GB54341 RNA-binding protein 33-like -0.594
102655912 L-aminoadipate-semialdehyde dehydrogenase-phosphopantetheinyl transferase-like 0.593
GB53420 uncharacterized protein LOC100576355 isoformX2 -0.591
GB48370 ATP-binding cassette sub-family B member 7, mitochondrial isoform X1 -0.591
726369 peptidyl-tRNA hydrolase 2, mitochondrial-like isoform 1 -0.591
GB46478 tectonin beta-propeller repeat-containing protein isoform X1 -0.591
GB42736 TM2 domain-containing protein CG10795-like 0.588
GB49087 formin-binding protein 1 homolog isoform X7 -0.588
GB50753 uncharacterized LOC408705 -0.586
GB46123 endonuclease G, mitochondrial-like -0.586
GB48574 thioredoxin-2 isoform 1 0.586
GB43232 transmembrane protein 222-like isoform 1 0.586
GB45285 eukaryotic translation initiation factor 3 subunit F-like 0.584
GB44631 uroporphyrinogen-III synthase-like 0.582
GB49994 60S ribosomal protein L26 0.581
GB52563 ATP-dependent helicase brm -0.579
GB54723 uncharacterized protein LOC726790 isoform X1 -0.578
GB53668 translocator protein-like 0.577
GB45374 40S ribosomal protein S23-like 0.576
GB46984 ribonuclease UK114-like isoform 1 0.572
102655352 uncharacterized protein LOC102655352 -0.572
GB45037 beta-lactamase-like protein 2-like isoform X2 -0.572
GB52107 tubulin alpha-1 chain-like 0.571
GB54139 flocculation protein FLO11-like -0.565
410017 protein OPI10 homolog 0.564
GB49177 60S ribosomal protein L27 isoform X2 0.557
GB54221 transmembrane protein 50A-like 0.556
GB54979 60S ribosomal protein L21 0.555
GB48111 proteasome subunit beta type-1 0.552
GB48745 5’-nucleotidase domain-containing protein 3-like -0.550
GB47079 hexokinase type 2-like isoform X3 -0.549
GB47441 V-type proton ATPase 21 kDa proteolipid subunit-like 0.549
GB41207 26S proteasome non-ATPase regulatory subunit 14 0.549
GB50274 transitional endoplasmic reticulum ATPase TER94 0.544
GB51683 annexin-B9-like isoform X1 0.544
GB54952 proteasome subunit alpha type-1-like 0.543
GB52253 protein PRRC2C-like isoform X2 -0.542
GB41648 protein chibby homolog 1-like 0.542
GB41363 26S protease regulatory subunit 6B isoform 1 0.541
GB53247 transmembrane emp24 domain-containing protein-like 0.541
GB48983 RING finger protein 121-like isoform X3 0.541
GB50873 60S ribosomal protein L30 isoform 1 0.540
GB54255 uncharacterized protein LOC551488 0.540
GB48810 60S ribosomal protein L8 0.537
GB41894 uncharacterized protein LOC411277 isoform X28 -0.536
GB49021 cuticular protein precursor 0.536
GB50131 phosphatidate phosphatase PPAPDC1A-like isoform X2 0.535
GB41811 filaggrin-like isoform X3 -0.534
GB51484 protein mago nashi 0.528
GB46705 muscle M-line assembly protein unc-89 isoform X5 -0.526
GB45978 dynein light chain Tctex-type isoform X2 0.526
GB43449 signal recognition particle 9 kDa protein 0.526
GB48150 actin-related protein 2/3 complex subunit 1A 0.525
GB54854 proteasome maturation protein-like 0.523
GB51545 dystrophin, isoforms A/C/F/G/H-like -0.523
GB49095 high affinity copper uptake protein 1-like isoformX1 0.523
GB43638 protein enhancer of sevenless 2B 0.522
GB51994 proteasome subunit beta type-6-like 0.520
GB53194 60S ribosomal protein L14 isoform X2 0.519
102656618 uncharacterized protein LOC102656618 isoform X1 -0.518
GB40539 40S ribosomal protein S20 0.518
GB41631 60S ribosomal protein L34 isoform X2 0.518
GB43938 cytosolic endo-beta-N-acetylglucosaminidase-like isoform X4 0.516
GB45878 tRNA-dihydrouridine(16/17) synthase [NAD(P)(+)]-like isoform X3 -0.516
GB44039 malate dehydrogenase, cytoplasmic-like isoform 1 0.513
GB55781 LOW QUALITY PROTEIN: uncharacterized protein LOC551170 -0.513
GB45526 eukaryotic translation initiation factor 6 isoform 1 0.510
GB52789 60S ribosomal protein L22 isoform 1 0.507
GB53626 myotrophin-like isoform 2 0.507
GB49364 splicing factor U2af 38 kDa subunit 0.505
GB44984 U5 small nuclear ribonucleoprotein 40 kDa protein-like isoform X1 0.504
GB50271 zinc transporter 1-like 0.503
GB49377 40S ribosomal protein S3a 0.501
GB50874 transcription factor Ken 2 -0.501
GB44147 60S ribosomal protein L15 0.498
GB46141 LOW QUALITY PROTEIN: vacuolar protein sorting-associated protein 29-like 0.494
GB51963 mitochondrial ribonuclease P protein 1 homolog -0.491
GB55901 ribosome biogenesis protein NSA2 homolog isoform X1 0.488
GB42036 protein SEC13 homolog isoform X2 0.485
GB40877 translocon-associated protein subunit delta 0.485
GB44205 proteasome subunit beta type-5-like 0.484
GB54151 uncharacterized protein LOC408463 isoform X12 -0.484
GB54590 polyadenylate-binding protein 1-like isoform X2 0.483
GB41157 RPII140-upstream gene protein-like -0.481
GB48423 small nuclear ribonucleoprotein F isoform 2 0.480
GB49608 protein angel-like isoform X1 -0.475
GB49812 RING-box protein 1A isoform X1 0.461
GB43697 mediator of RNA polymerase II transcription subunit 16 isoform X3 0.457
GB41553 Golgi phosphoprotein 3 homolog rotini-like isoform X1 0.455
GB43548 40S ribosomal protein SA 0.449
GB45181 probable Bax inhibitor 1 0.447
GB53086 alcohol dehydrogenase class-3 isoform X2 0.446
GB41724 uncharacterized protein LOC727081 -0.446
GB54533 protein unc-13 homolog D isoform X5 -0.445
GB40882 40S ribosomal protein S13 isoform X1 0.445
GB50230 V-type proton ATPase subunit e 2-like 0.445
102654691 protein translation factor SUI1 homolog 0.445
GB51787 myosin light chain alkali-like isoform X5 0.444
GB41908 PERQ amino acid-rich with GYF domain-containing protein CG11148-like isoform X3 -0.443
GB53138 inorganic pyrophosphatase-like 0.437
GB48250 putative gamma-glutamylcyclotransferase CG2811-like isoform X4 0.436
GB46763 excitatory amino acid transporter 3 0.436
GB53415 WW domain-binding protein 2-like isoform X1 0.432
GB47606 ER membrane protein complex subunit 4-like isoform 1 0.431
GB42675 adenylate cyclase type 2-like -0.430
GB44312 hydroxyacylglutathione hydrolase, mitochondrial-like isoform X2 0.428
102654127 neurochondrin homolog -0.423
GB47938 uncharacterized protein LOC412825 isoform X1 -0.421
GB55056 spermatogenesis-associated protein 20 isoform X2 -0.420
GB41084 60S ribosomal protein L38 0.412
GB47810 regulator of gene activity protein isoform X3 0.410
GB40946 serine/threonine-protein phosphatase 2A 65 kDa regulatory subunit A alpha isoform-like isoform X1 0.409
GB42780 CCHC-type zinc finger protein CG3800-like isoform X3 0.409
GB43229 GTP-binding nuclear protein Ran isoform X1 0.407
GB50244 NHL repeat-containing protein 2 isoform X4 -0.406
GB45684 protein spire-like isoform X4 -0.406
GB52073 probable citrate synthase 1, mitochondrial-like -0.402
GB45856 protein GPR107-like isoform X4 0.401
GB47542 eukaryotic translation initiation factor 3 subunit J isoform 1 0.399
GB53243 LOW QUALITY PROTEIN: probable phosphorylase b kinase regulatory subunit beta-like -0.395
GB55892 glutamate-rich WD repeat-containing protein 1-like 0.395
GB43105 casein kinase II subunit alpha isoform X6 0.390
GB43537 probable 28S ribosomal protein S16, mitochondrial 0.388
GB44496 probable serine incorporator isoformX1 0.376
GB43855 LOW QUALITY PROTEIN: coatomer subunit beta’ 0.374
GB40073 COP9 signalosome complex subunit 8-like 0.373
GB47100 putative glutamate synthase [NADPH]-like isoform X4 -0.372
GB42786 microtubule-associated protein RP/EB family member 1-like isoform X4 0.372
GB54789 GMP synthase [glutamine-hydrolyzing] 0.371
GB40767 phosphoglycolate phosphatase-like -0.370
GB52212 polyubiquitin-A-like isoform X2 0.370
GB52256 60S ribosomal protein L5 0.370
GB50925 prostaglandin E synthase 2-like -0.360
GB53725 splicing factor 3B subunit 1-like isoform X2 -0.355
GB44870 zinc finger protein 706-like isoform X3 0.355
GB45375 rhomboid-7 isoform X1 0.346
GB45044 uncharacterized protein LOC409396 isoform X5 -0.334
GB50909 dual 3’,5’-cyclic-AMP and -GMP phosphodiesterase 11-like, transcript variant X4 -0.333
GB44907 myeloid leukemia factor isoform X3 0.331
GB44333 flocculation protein FLO11-like isoform X1 -0.322
GB46562 40S ribosomal protein S24-like isoform X2 0.321
GB45017 RNA pseudouridylate synthase domain-containing protein 2-like isoform X3 -0.317
GB48312 pre-mRNA-splicing factor RBM22-like 0.316
GB47103 elongation factor 1-beta’ 0.310
GB48207 proteasomal ubiquitin receptor ADRM1 homolog isoform X1 0.270
GB40887 V-type proton ATPase subunit E isoform 3 0.266
GB41152 uncharacterized protein C6orf106 homolog 0.213
GB45678 1-acylglycerol-3-phosphate O-acyltransferase ABHD5-like isoform X1 -0.192
GB44576 ester hydrolase C11orf54 homolog 0.189

Bombus terrestris

Table S3: The single significantly differentially expressed gene (EBseq; FDR-corrected posterior probability of differential expression p < 0.05) in Bombus terrestris. Positive fold change values indicate higher expression in the control, while negative values indicate higher expression in the queen pheromone treatment. The second and third columns give the best BLAST hit for this gene in A. mellifera plus the name of the A. mellifera putative ortholog.

saveRDS(bombus.de, file = "supplement/tab_S3.rds")
kable(bombus.de, "html") %>%
  kable_styling()
Gene Apis BLAST Name Log2 FC
100648170 GB48391 mucin-2-like 1.071

Lasius flavus

Table S4: List of the 290 significantly differentially expressed genes (EBseq; FDR-corrected posterior probability of differential expression p < 0.05) in Lasius flavus, listed in order of fold change in gene expression on a Log\(_2\) scale. Positive fold change values indicate higher expression in the control, while negative values indicate higher expression in the queen pheromone treatment. The second and third columns give the best BLAST hit for this gene in A. mellifera plus the name of the A. mellifera putative ortholog.

saveRDS(flavus.de, file = "supplement/tab_S4.rds")
kable.table(flavus.de)
Gene Apis BLAST Name Log2 FC
TRINITY_DN19074_c0_g2 GB43902 hexaprenyldihydroxybenzoate methyltransferase, mitochondrial-like 7.514
TRINITY_DN2701_c0_g1 GB52729 aspartate–tRNA ligase, cytoplasmic 7.481
TRINITY_DN14108_c0_g2 7.468
TRINITY_DN36041_c0_g1 6.629
TRINITY_DN13621_c0_g1 6.549
TRINITY_DN18780_c0_g2 -6.440
TRINITY_DN14430_c0_g1 6.278
TRINITY_DN32671_c0_g2 6.121
TRINITY_DN14910_c0_g1 XP_016769216.1 5.800
TRINITY_DN19071_c0_g1 -5.776
TRINITY_DN5663_c0_g2 XP_006568418.2 -5.365
TRINITY_DN13527_c1_g3 5.259
TRINITY_DN2506_c0_g2 5.133
TRINITY_DN9902_c0_g2 5.069
TRINITY_DN6503_c0_g3 551397 28S ribosomal protein S18a, mitochondrial isoform 2 5.044
TRINITY_DN10699_c0_g1 4.901
TRINITY_DN5102_c0_g1 XP_016771437.1 4.901
TRINITY_DN6994_c0_g1 4.859
TRINITY_DN13376_c3_g2 4.858
TRINITY_DN9565_c0_g3 GB45250 uncharacterized protein LOC409595 4.811
TRINITY_DN1013_c0_g1 GB52059 eukaryotic translation initiation factor 4H-like isoform X1 4.709
TRINITY_DN11616_c0_g1 4.696
TRINITY_DN1845_c0_g2 GB52253 protein PRRC2C-like isoform X2 4.658
TRINITY_DN7242_c0_g1 -4.646
TRINITY_DN31547_c0_g3 4.613
TRINITY_DN13376_c3_g3 4.569
TRINITY_DN6298_c0_g3 4.553
TRINITY_DN2720_c0_g2 -4.522
TRINITY_DN2583_c0_g2 4.460
TRINITY_DN24980_c0_g3 -4.393
TRINITY_DN12959_c0_g3 4.390
TRINITY_DN4813_c0_g1 4.322
TRINITY_DN6331_c0_g2 4.303
TRINITY_DN10925_c0_g1 4.278
TRINITY_DN14174_c1_g3 4.233
TRINITY_DN23574_c0_g3 4.173
TRINITY_DN6054_c0_g1 XP_016771772.1 4.143
TRINITY_DN32287_c0_g1 4.133
TRINITY_DN1060_c0_g1 4.115
TRINITY_DN6965_c0_g3 4.097
TRINITY_DN5087_c0_g1 XP_003249576.2 4.069
TRINITY_DN10904_c0_g1 4.050
TRINITY_DN4900_c0_g1 4.049
TRINITY_DN14065_c0_g2 4.015
TRINITY_DN2102_c0_g6 GB40389 profilin 3.751
TRINITY_DN12195_c1_g3 102656074 reticulon-4-like isoform X6 3.710
TRINITY_DN2302_c0_g2 3.676
TRINITY_DN9563_c1_g3 XP_016770117.1 3.347
TRINITY_DN11562_c2_g1 XP_016769630.1 3.211
TRINITY_DN6503_c0_g2 551397 28S ribosomal protein S18a, mitochondrial isoform 2 3.210
TRINITY_DN3428_c0_g1 GB53155 maternal embryonic leucine zipper kinase-like 3.168
TRINITY_DN11833_c0_g2 3.162
TRINITY_DN1150_c0_g2 3.151
TRINITY_DN14156_c9_g2 XP_016769763.1 3.146
TRINITY_DN7447_c0_g1 GB10293 aubergine 3.125
TRINITY_DN12563_c0_g2 XP_016768561.1 3.097
TRINITY_DN19328_c0_g2 GB49105 ecdysteroid-regulated gene E74 isoform X10 2.921
TRINITY_DN19071_c0_g5 -2.920
TRINITY_DN3355_c0_g1 XP_016772030.1 2.912
TRINITY_DN1453_c0_g2 2.891
TRINITY_DN34334_c0_g1 -2.831
TRINITY_DN9365_c0_g1 2.823
TRINITY_DN2907_c0_g1 GB52114 protein trachealess-like isoform X7 2.821
TRINITY_DN29060_c0_g1 2.784
TRINITY_DN5450_c0_g3 2.778
TRINITY_DN6679_c1_g1 -2.777
TRINITY_DN13106_c0_g1 -2.766
TRINITY_DN6249_c0_g2 2.762
TRINITY_DN12570_c0_g2 XP_016772046.1 2.752
TRINITY_DN29060_c0_g2 -2.748
TRINITY_DN1453_c0_g1 2.718
TRINITY_DN4551_c0_g1 2.665
TRINITY_DN5934_c0_g2 2.664
TRINITY_DN21319_c0_g1 2.647
TRINITY_DN16415_c0_g2 2.644
TRINITY_DN6639_c0_g2 GB51740 CD63 antigen 2.628
TRINITY_DN8686_c0_g6 2.525
TRINITY_DN27412_c0_g1 2.511
TRINITY_DN7556_c0_g1 2.479
TRINITY_DN12097_c3_g11 2.467
TRINITY_DN19324_c0_g1 2.464
TRINITY_DN5257_c0_g2 GB51614 probable methylthioribulose-1-phosphate dehydratase-like 2.451
TRINITY_DN3033_c0_g1 GB47735 endonuclease III-like protein 1-like 2.441
TRINITY_DN23065_c0_g1 2.434
TRINITY_DN30835_c0_g2 2.337
TRINITY_DN30278_c0_g7 2.328
TRINITY_DN13221_c0_g7 2.244
TRINITY_DN13083_c0_g1 2.202
TRINITY_DN12097_c3_g6 2.167
TRINITY_DN6372_c0_g3 2.154
TRINITY_DN13237_c2_g6 -2.137
TRINITY_DN3870_c0_g2 2.108
TRINITY_DN7016_c0_g2 GB47843 uncharacterized protein LOC100576559 isoform X2 1.972
TRINITY_DN12195_c1_g4 102656074 reticulon-4-like isoform X6 -1.727
TRINITY_DN15459_c0_g1 1.644
TRINITY_DN7587_c0_g2 GB52590 fatty acid synthase-like isoform 1 -1.363
TRINITY_DN3266_c0_g1 1.320
TRINITY_DN5353_c0_g1 GB43825 lysosomal aspartic protease 1.297
TRINITY_DN7865_c0_g1 XP_016770671.1 1.257
TRINITY_DN13667_c2_g1 1.226
TRINITY_DN9568_c0_g3 -1.068
TRINITY_DN8668_c0_g1 GB52590 fatty acid synthase-like isoform 1 -1.025
TRINITY_DN8075_c0_g1 -1.023
TRINITY_DN8944_c1_g2 -0.955
TRINITY_DN13195_c1_g2 0.950
TRINITY_DN11726_c1_g1 GB52590 fatty acid synthase-like isoform 1 -0.932
TRINITY_DN14247_c8_g2 GB52590 fatty acid synthase-like isoform 1 -0.926
TRINITY_DN61_c0_g1 GB45775 pancreatic triacylglycerol lipase-like isoform X2 -0.888
TRINITY_DN2623_c0_g1 GB43825 lysosomal aspartic protease 0.862
TRINITY_DN12575_c0_g1 GB55263 putative fatty acyl-CoA reductase CG5065-like -0.832
TRINITY_DN14020_c0_g1 GB46188 trichohyalin-like isoform X1 0.728
TRINITY_DN13013_c0_g1 XP_016768441.1 0.710
TRINITY_DN12756_c2_g1 0.691
TRINITY_DN9649_c0_g1 NP_001305411.1 0.685
TRINITY_DN13574_c1_g2 GB40681 elongation of very long chain fatty acids protein 1-like -0.679
TRINITY_DN9287_c0_g1 XP_016768964.1 0.671
TRINITY_DN13318_c0_g1 GB46888 alpha-methylacyl-CoA racemase-like -0.612
TRINITY_DN3111_c0_g1 0.588
TRINITY_DN13226_c0_g1 GB47475 protein lethal(2)essential for life-like isoform 1 0.586
TRINITY_DN5134_c0_g1 XP_016770229.1 0.578
TRINITY_DN12647_c0_g1 XP_016773029.1 -0.572
TRINITY_DN14059_c0_g1 XP_016768888.1 0.567
TRINITY_DN13252_c1_g1 GB50415 diacylglycerol kinase theta-like isoform X7 0.559
TRINITY_DN13742_c0_g1 GB46657 galactokinase-like -0.518
TRINITY_DN13982_c0_g1 XP_016769706.1 -0.517
TRINITY_DN32324_c0_g1 102656101 uncharacterized protein LOC102656101 0.517
TRINITY_DN12496_c0_g1 GB54423 uncharacterized protein LOC551958 0.511
TRINITY_DN11328_c0_g1 GB51479 ras guanine nucleotide exchange factor P-like isoform X3 0.509
TRINITY_DN6523_c0_g1 GB40976 heat shock protein 90 -0.504
TRINITY_DN12344_c0_g1 0.503
TRINITY_DN15124_c0_g1 0.500
TRINITY_DN12742_c1_g1 XP_016767680.1 0.490
TRINITY_DN11193_c0_g1 GB53045 ATP-binding cassette sub-family G member 1-like isoform X1 -0.481
TRINITY_DN10448_c0_g2 GB41603 PTB domain-containing adapter protein ced-6 isoform X2 -0.474
TRINITY_DN1154_c0_g1 0.474
TRINITY_DN14164_c3_g1 GB55490 uncharacterized protein LOC410793 -0.473
TRINITY_DN14136_c5_g1 GB55016 quinone oxidoreductase-like isoform X2 0.465
TRINITY_DN9952_c0_g1 GB43823 chemosensory protein 1 precursor 0.462
TRINITY_DN8450_c0_g1 GB46286 zinc carboxypeptidase A 1-like isoform X1 0.454
TRINITY_DN12807_c0_g1 XP_016769434.1 0.450
TRINITY_DN13250_c5_g1 GB45937 intracellular protein transport protein USO1 isoform X2 0.445
TRINITY_DN6544_c0_g1 GB52074 6-phosphogluconate dehydrogenase, decarboxylating -0.445
TRINITY_DN13581_c2_g2 GB42792 uncharacterized protein LOC409805 isoform X3 0.444
TRINITY_DN36181_c0_g1 0.442
TRINITY_DN2719_c0_g1 GB54446 arginine kinase isoform X2 0.441
TRINITY_DN13519_c0_g1 GB42797 protein takeout-like 0.440
TRINITY_DN7060_c0_g1 GB49607 lysosome-associated membrane glycoprotein 1-like isoform 2 -0.438
TRINITY_DN1392_c0_g1 GB44205 proteasome subunit beta type-5-like -0.434
TRINITY_DN10466_c0_g1 GB44431 26S protease regulatory subunit 4 isoform 1 -0.428
TRINITY_DN13148_c0_g1 GB44213 filamin-like 0.426
TRINITY_DN13702_c3_g1 XP_016769732.1 0.423
TRINITY_DN12417_c0_g2 GB45456 flocculation protein FLO11-like isoform X2 0.422
TRINITY_DN23399_c0_g1 0.417
TRINITY_DN11737_c0_g1 XP_016766478.1 -0.416
TRINITY_DN12348_c0_g1 GB44703 proteasome activator complex subunit 4-like -0.415
TRINITY_DN13581_c1_g3 XP_016767189.1 0.406
TRINITY_DN11774_c0_g1 XP_016772498.1 0.387
TRINITY_DN3048_c0_g1 GB40770 dehydrogenase/reductase SDR family member 11-like isoform X2 0.387
TRINITY_DN13700_c5_g3 GB42840 leukocyte receptor cluster member 8 homolog isoform X4 0.387
TRINITY_DN13455_c0_g1 GB45128 trifunctional enzyme subunit alpha, mitochondrial-like -0.380
TRINITY_DN14019_c2_g1 409060 neurofilament heavy polypeptide-like isoform X2 0.377
TRINITY_DN11786_c1_g1 GB51214 troponin T, skeletal muscle 0.374
TRINITY_DN9982_c0_g1 GB51787 myosin light chain alkali-like isoform X5 0.372
TRINITY_DN27322_c0_g1 GB40866 heat shock protein cognate 4 -0.369
TRINITY_DN5956_c0_g1 0.366
TRINITY_DN6208_c0_g1 GB49757 fatty acid binding protein 0.359
TRINITY_DN11594_c0_g1 GB52643 poly(U)-specific endoribonuclease homolog 0.355
TRINITY_DN9687_c0_g1 0.350
TRINITY_DN14119_c3_g1 726668 PDZ and LIM domain protein 3 isoform X7 0.348
TRINITY_DN5256_c0_g1 0.345
TRINITY_DN10396_c0_g1 GB42607 cytochrome b5-like isoform X1 -0.344
TRINITY_DN5623_c0_g1 GB54817 muscle-specific protein 20 0.343
TRINITY_DN10620_c0_g1 GB42732 long-chain-fatty-acid–CoA ligase 3-like isoform X2 -0.325
TRINITY_DN12788_c0_g1 XP_016771468.1 0.325
TRINITY_DN12757_c0_g1 GB55610 MOSC domain-containing protein 2, mitochondrial-like 0.324
TRINITY_DN10923_c0_g1 GB40141 venom serine carboxypeptidase -0.321
TRINITY_DN10232_c0_g1 -0.319
TRINITY_DN12105_c0_g1 XP_016768441.1 0.318
TRINITY_DN7549_c0_g1 XP_016768456.1 0.315
TRINITY_DN3036_c0_g1 GB52326 chemosensory protein 4 precursor 0.313
TRINITY_DN12756_c2_g4 XP_016770894.1 0.311
TRINITY_DN14002_c3_g1 XP_016770982.1 0.307
TRINITY_DN27284_c0_g1 GB50274 transitional endoplasmic reticulum ATPase TER94 -0.306
TRINITY_DN12138_c0_g1 GB47306 sulfhydryl oxidase 1-like 0.305
TRINITY_DN13865_c0_g1 GB47963 probable E3 ubiquitin-protein ligase HERC4-like isoform X3 0.302
TRINITY_DN8423_c0_g1 XP_016768214.1 -0.298
TRINITY_DN27569_c0_g1 GB52736 ATP synthase subunit beta, mitochondrial isoform X1 0.297
TRINITY_DN14286_c2_g1 GB54861 LOW QUALITY PROTEIN: counting factor associated protein D-like -0.294
TRINITY_DN14128_c1_g1 XP_006568818.2 0.291
TRINITY_DN11359_c0_g1 XP_016768872.1 -0.287
TRINITY_DN9072_c0_g1 XP_016768321.1 -0.287
TRINITY_DN28113_c0_g1 -0.285
TRINITY_DN10911_c0_g1 XP_016770213.1 -0.277
TRINITY_DN12726_c3_g1 GB42787 dentin sialophosphoprotein-like isoform X4 -0.274
TRINITY_DN6072_c0_g1 XP_016771431.1 -0.273
TRINITY_DN13789_c0_g2 XP_016767109.1 0.273
TRINITY_DN14037_c0_g1 XP_016767155.1 0.272
TRINITY_DN13738_c0_g1 XP_016772667.1 0.271
TRINITY_DN993_c0_g3 0.270
TRINITY_DN7531_c0_g3 GB51710 eukaryotic initiation factor 4A-like isoformX2 0.260
TRINITY_DN11232_c0_g1 GB40240 myosin regulatory light chain 2 0.258
TRINITY_DN12074_c1_g1 GB47462 protein disulfide-isomerase A3 isoform 2 -0.256
TRINITY_DN11684_c0_g1 GB55537 transketolase isoform 1 -0.248
TRINITY_DN14138_c2_g1 GB48850 fatty-acid amide hydrolase 2-B-like -0.248
TRINITY_DN13963_c1_g1 XP_016768450.1 0.247
TRINITY_DN12180_c0_g1 XP_016772046.1 0.246
TRINITY_DN13233_c1_g1 XP_016768217.1 -0.244
TRINITY_DN12080_c1_g1 XP_016769481.1 -0.241
TRINITY_DN11171_c0_g1 GB42468 phospholipase B1, membrane-associated-like isoform X1 -0.239
TRINITY_DN13982_c0_g3 XP_016769706.1 -0.237
TRINITY_DN14752_c0_g1 GB50123 myophilin-like 0.226
TRINITY_DN8270_c0_g1 GB43276 aminopeptidase N-like isoform X1 0.226
TRINITY_DN12844_c1_g1 GB47885 probable cytochrome P450 304a1 -0.224
TRINITY_DN11885_c1_g1 GB55598 troponin I isoform X23 0.218
TRINITY_DN8742_c0_g1 XP_016767150.1 -0.216
TRINITY_DN14111_c0_g1 GB46705 muscle M-line assembly protein unc-89 isoform X5 0.213
TRINITY_DN14002_c4_g1 0.212
TRINITY_DN7802_c0_g1 GB41358 elongation factor 1-alpha -0.210
TRINITY_DN14006_c0_g1 XP_016767101.1 -0.208
TRINITY_DN8847_c0_g1 GB46772 very-long-chain enoyl-CoA reductase-like -0.201
TRINITY_DN14179_c1_g1 GB40461 calreticulin -0.186
TRINITY_DN7523_c0_g1 -0.183
TRINITY_DN12909_c0_g1 XP_016770377.1 0.181
TRINITY_DN8174_c0_g1 GB47880 superoxide dismutase 1 -0.175
TRINITY_DN14199_c2_g1 -0.173
TRINITY_DN3676_c0_g2 GB49773 sequestosome-1 0.168
TRINITY_DN3648_c0_g1 GB45181 probable Bax inhibitor 1 -0.167
TRINITY_DN9738_c0_g1 GB44206 death-associated protein 1-like -0.167
TRINITY_DN3697_c0_g1 GB54368 prostaglandin E synthase 3-like isoform X2 -0.165
TRINITY_DN13223_c0_g1 GB54315 uncharacterized protein LOC724126 -0.157
TRINITY_DN9957_c0_g1 GB43831 ATP-binding cassette sub-family D member 3-like -0.157
TRINITY_DN1533_c0_g1 XP_392401.3 -0.155
TRINITY_DN12307_c0_g1 GB47029 uncharacterized protein LOC724558 -0.153
TRINITY_DN13021_c0_g1 XP_006571535.2 -0.144
TRINITY_DN11571_c0_g2 XP_001119981.3 -0.138
TRINITY_DN14152_c0_g10 XP_016771978.1 0.136
TRINITY_DN13002_c1_g1 XP_016767675.1 -0.131
TRINITY_DN13997_c1_g2 XP_016771269.1 0.130
TRINITY_DN7931_c0_g1 GB49321 D-arabinitol dehydrogenase 1-like -0.128
TRINITY_DN12756_c2_g5 XP_016770894.1 -0.126
TRINITY_DN1575_c0_g1 0.124
TRINITY_DN1616_c0_g1 GB41545 MD-2-related lipid-recognition protein-like 0.120
TRINITY_DN12630_c0_g1 GB45258 isocitrate dehydrogenase [NADP] cytoplasmic isoform 2 -0.119
TRINITY_DN14083_c3_g1 GB55263 putative fatty acyl-CoA reductase CG5065-like -0.117
TRINITY_DN4494_c0_g2 GB47990 tropomyosin-1-like 0.116
TRINITY_DN1524_c0_g1 GB46920 iron-sulfur cluster assembly enzyme ISCU, mitochondrial 0.115
TRINITY_DN13221_c0_g9 XP_016769341.1 0.107
TRINITY_DN13959_c2_g1 GB49688 peroxidase isoformX2 0.104
TRINITY_DN12634_c0_g1 GB43575 trehalase-like isoform X2 -0.093
TRINITY_DN13844_c1_g1 XP_016767538.1 -0.092
TRINITY_DN10322_c0_g1 XP_016769014.1 -0.088
TRINITY_DN13381_c0_g1 GB51633 protein HIRA homolog 0.084
TRINITY_DN12970_c0_g2 GB44208 WD repeat-containing protein 37-like isoform X4 0.083
TRINITY_DN3647_c0_g1 GB53550 heat shock protein beta-1-like isoform X3 -0.081
TRINITY_DN8558_c0_g1 GB46713 translation elongation factor 2-like isoform 1 -0.079
TRINITY_DN11372_c0_g1 GB53755 juvenile hormone esterase precursor 0.071
TRINITY_DN6049_c0_g1 0.068
TRINITY_DN10813_c0_g1 GB51753 uncharacterized protein LOC100576760 isoform X2 -0.066
TRINITY_DN10427_c0_g1 GB51782 carboxypeptidase Q-like isoform 1 -0.065
TRINITY_DN8685_c0_g4 GB43825 lysosomal aspartic protease -0.065
TRINITY_DN13047_c0_g1 XP_016768229.1 0.061
TRINITY_DN6208_c0_g2 GB49757 fatty acid binding protein -0.056
TRINITY_DN13652_c0_g1 GB42422 ADP/ATP translocase 0.054
TRINITY_DN13884_c0_g2 GB47405 neutral alpha-glucosidase AB-like isoform 2 0.051
TRINITY_DN13634_c0_g1 GB45913 protein lethal(2)essential for life-like -0.049
TRINITY_DN1723_c0_g1 GB52324 chemosensory protein 3 precursor 0.048
TRINITY_DN18895_c0_g1 GB55581 membrane-associated progesterone receptor component 1-like isoform 2 -0.044
TRINITY_DN8126_c0_g1 GB40779 transaldolase -0.044
TRINITY_DN10665_c0_g1 GB42829 juvenile hormone epoxide hydrolase 1 -0.042
TRINITY_DN8184_c0_g1 0.040
TRINITY_DN11577_c0_g1 GB55096 NADP-dependent malic enzyme isoform X3 0.040
TRINITY_DN18992_c0_g1 XP_016772082.1 0.039
TRINITY_DN11030_c0_g1 GB49240 aldehyde dehydrogenase, mitochondrial isoform 1 -0.038
TRINITY_DN11459_c0_g1 GB50598 aldose reductase-like isoform 1 -0.038
TRINITY_DN13961_c1_g3 GB52588 conserved oligomeric Golgi complex subunit 7 -0.037
TRINITY_DN12872_c0_g1 GB53333 V-type proton ATPase catalytic subunit A-like isoform X3 0.035
TRINITY_DN13271_c0_g1 GB40312 choline/ethanolamine kinase-like isoform X4 0.030
TRINITY_DN13702_c8_g1 GB47395 uncharacterized protein CG7816-like -0.030
TRINITY_DN13400_c0_g1 GB54421 uncharacterized protein DDB_G0287625-like 0.023
TRINITY_DN10682_c0_g1 GB50252 GTP-binding protein SAR1b-like isoform X4 -0.021
TRINITY_DN8055_c0_g1 -0.021
TRINITY_DN9151_c0_g1 GB45147 clavesin-2-like 0.021
TRINITY_DN11885_c3_g1 GB47880 superoxide dismutase 1 -0.019
TRINITY_DN12979_c1_g1 GB49347 prostaglandin reductase 1-like 0.013
TRINITY_DN14085_c1_g1 XP_016769919.1 -0.011
TRINITY_DN11118_c1_g1 GB44422 uncharacterized protein LOC412543 isoform X3 -0.010
TRINITY_DN14002_c1_g1 0.004
TRINITY_DN7306_c0_g2 XP_016769332.1 -0.004
TRINITY_DN13747_c0_g1 XP_016769944.1 -0.003
TRINITY_DN10790_c0_g1 0.000

Lasius niger

Table S5: List of the 135 significantly differentially expressed genes (EBseq; FDR-corrected posterior probability of differential expression p < 0.05) in Lasius niger, listed in order of fold change in gene expression on a Log\(_2\) scale. Positive fold change values indicate higher expression in the control, while negative values indicate higher expression in the queen pheromone treatment. The second and third columns give the best BLAST hit for this gene in A. mellifera plus the name of the A. mellifera putative ortholog.

saveRDS(niger.de, file = "supplement/tab_S5.rds")
kable.table(niger.de)
Gene Apis BLAST Name Log2 FC
XLOC_001009 5.916
RF55_9944 GB55171 major royal jelly protein 1 isoform X1 5.060
RF55_873 XP_016773511.1 4.638
XLOC_000784 3.626
RF55_874 XP_016766165.1 3.550
XLOC_016588 3.077
RF55_9436 2.813
RF55_3510 GB53672 failed axon connections isoform X2 -2.471
RF55_15864 -2.439
XLOC_020552 2.437
RF55_783 2.206
RF55_6001 -2.150
XLOC_013573 2.150
RF55_4870 XP_006563262.2 -2.031
XLOC_022706 -1.091
RF55_7689 XP_003250465.2 -1.030
RF55_19841 GB52590 fatty acid synthase-like isoform 1 -1.015
RF55_21338 GB52590 fatty acid synthase-like isoform 1 -0.923
RF55_13568 XP_006571191.2 0.882
RF55_2210 GB49869 microsomal triglyceride transfer protein large subunit isoform X1 -0.879
RF55_6639 GB48784 cytochrome c 0.779
RF55_15245 GB43617 uncharacterized membrane protein DDB_G0293934-like isoform X1 0.734
RF55_14443 GB51356 cytochrome P450 4G11 0.726
RF55_5140 XP_016767978.1 0.656
XLOC_003947 0.655
XLOC_019296 -0.643
XLOC_005895 -0.625
XLOC_010120 0.619
RF55_3431 GB47849 pyrroline-5-carboxylate reductase 2-like isoform X2 0.611
RF55_6542 GB52074 6-phosphogluconate dehydrogenase, decarboxylating -0.603
RF55_6567 552211 protein THEM6-like -0.597
RF55_11093 GB51174 uncharacterized protein DDB_G0284459-like 0.593
RF55_9960 GB52023 cytochrome P450 6AQ1 isoform X3 -0.584
RF55_14139 XP_016768457.1 0.561
RF55_16317 XP_016770827.1 -0.523
RF55_16054 GB55082 protein PBDC1-like 0.489
XLOC_004490 -0.474
RF55_9918 GB47885 probable cytochrome P450 304a1 0.470
XLOC_015751 -0.442
RF55_12610 GB40866 heat shock protein cognate 4 -0.432
RF55_11067 GB46772 very-long-chain enoyl-CoA reductase-like -0.431
RF55_6451 GB55598 troponin I isoform X23 0.430
RF55_10641 XP_016769078.1 -0.430
RF55_4656 GB42792 uncharacterized protein LOC409805 isoform X3 0.415
RF55_4036 GB44208 WD repeat-containing protein 37-like isoform X4 0.407
XLOC_002901 -0.398
RF55_16927 XP_006564499.2 0.394
RF55_4554 GB47990 tropomyosin-1-like 0.393
RF55_15079 GB41028 ATP synthase subunit alpha, mitochondrial isoform 1 0.375
RF55_3507 GB41333 DNA-directed RNA polymerase III subunit RPC1-like isoform X1 -0.375
RF55_5177 GB43902 hexaprenyldihydroxybenzoate methyltransferase, mitochondrial-like -0.368
RF55_13988 GB55263 putative fatty acyl-CoA reductase CG5065-like -0.362
RF55_10649 0.359
RF55_2038 GB51787 myosin light chain alkali-like isoform X5 0.350
RF55_3707 GB55537 transketolase isoform 1 -0.342
XLOC_005759 0.330
RF55_10912 GB47880 superoxide dismutase 1 -0.324
RF55_18605 XP_016770827.1 -0.315
RF55_17057 GB52590 fatty acid synthase-like isoform 1 -0.312
RF55_3648 XP_016768682.1 -0.310
RF55_5902 GB55302 trehalose transporter 1 isoform X6 0.308
RF55_12242 GB41912 trans-1,2-dihydrobenzene-1,2-diol dehydrogenase-like -0.286
RF55_10676 GB40240 myosin regulatory light chain 2 0.279
RF55_4654 GB45673 alpha-N-acetylgalactosaminidase-like 0.277
XLOC_012799 0.273
XLOC_018477 -0.268
RF55_6754 XP_016772080.1 0.254
RF55_3967 GB46039 tubulin alpha-1 chain-like -0.251
RF55_1582 GB45012 adenosylhomocysteinase-like 0.248
RF55_2761 XP_003249233.2 0.246
RF55_2493 GB45913 protein lethal(2)essential for life-like -0.244
RF55_15035 GB51356 cytochrome P450 4G11 -0.223
RF55_5799 GB50123 myophilin-like 0.216
RF55_5341 GB50508 fibrillin-2 -0.215
RF55_598 GB40021 probable serine/threonine-protein kinase clkA-like -0.215
RF55_5109 XP_016767675.1 -0.211
RF55_2407 XP_016768440.1 0.207
RF55_3343 GB46290 acetyl-coenzyme A synthetase-like -0.205
RF55_10752 XP_016771487.1 0.204
RF55_19196 GB41311 actin, indirect flight muscle-like 0.202
RF55_5837 GB43879 aquaporin AQPcic-like isoform X2 -0.191
RF55_13604 XP_016767981.1 0.185
RF55_3994 GB49175 4-hydroxyphenylpyruvate dioxygenase-like 0.181
RF55_18796 GB53412 fatty acid synthase-like -0.180
XLOC_001770 0.175
RF55_1934 GB54827 synaptotagmin 1 -0.169
RF55_5219 GB51753 uncharacterized protein LOC100576760 isoform X2 -0.163
RF55_778 GB42422 ADP/ATP translocase 0.154
RF55_10519 GB54446 arginine kinase isoform X2 0.141
RF55_364 0.137
RF55_2231 XP_016773593.1 -0.134
XLOC_008839 -0.132
RF55_5431 -0.129
RF55_5198 XP_016768517.1 0.124
RF55_11370 XP_016772844.1 -0.115
RF55_13251 GB52590 fatty acid synthase-like isoform 1 -0.113
RF55_6842 GB43052 paramyosin, long form-like 0.109
RF55_6077 GB54423 uncharacterized protein LOC551958 -0.108
RF55_6180 GB40758 icarapin-like 0.108
XLOC_005990 -0.099
RF55_10150 XP_016769706.1 0.099
RF55_1045 GB54861 LOW QUALITY PROTEIN: counting factor associated protein D-like -0.097
RF55_3186 XP_016770377.1 0.092
XLOC_020265 -0.089
XLOC_019117 -0.085
RF55_4175 GB44311 actin related protein 1 0.083
XLOC_016272 -0.079
RF55_5206 GB40735 fructose-bisphosphate aldolase-like isoform X1 0.071
RF55_4024 XP_016767817.1 0.069
RF55_9453 GB55096 NADP-dependent malic enzyme isoform X3 -0.067
RF55_8355 GB42809 translationally-controlled tumor protein homolog isoform 1 0.063
RF55_3575 XP_016768967.1 -0.062
XLOC_011290 0.061
RF55_5559 GB52107 tubulin alpha-1 chain-like 0.061
RF55_3308 -0.059
XLOC_020794 0.059
XLOC_018966 0.059
RF55_1104 XP_016769017.1 0.048
RF55_652 GB54354 uncharacterized protein DDB_G0274915-like isoform X2 0.045
RF55_3854 XP_006571125.2 -0.036
RF55_6873 GB47106 NADH-ubiquinone oxidoreductase 75 kDa subunit, mitochondrial -0.035
RF55_15158 GB42794 circadian clock-controlled protein-like isoform 1 -0.034
RF55_4888 GB40779 transaldolase 0.034
XLOC_019193 0.026
XLOC_013126 -0.025
XLOC_017016 0.025
XLOC_016458 -0.024
XLOC_013131 -0.013
RF55_10886 GB41427 catalase -0.012
XLOC_003165 -0.010
RF55_9333 GB49688 peroxidase isoformX2 0.008
XLOC_004885 -0.005
RF55_5677 GB46713 translation elongation factor 2-like isoform 1 0.004
RF55_14822 GB43823 chemosensory protein 1 precursor 0.004
RF55_11002 XP_016768909.1 0.002

Genes that are differentially expressed in multiple species

In Tables S6-S7, we have simply listed the genes that showed statistically significant differential expression in two or more species. This method is expected to make few ‘false positive’ errors, but it probably misses many of true overlaps because our study has modest power to detect differential expression (that is, the ‘false negative’ rate is high).

In Table S8, we instead look for similarities between species using a method that ranks genes from most- to least- phermone sensitive based on log fold change, alleviating the problem of low power. To do this, we select the top \(n\) genes per species (where \(n\) = 100, 200… 500), based on the absolute magnitude of the log fold-change response to queen pheromone, giving a list of the most pheromone-sensitive genes. This method produces fewer false negatives in our search for overlapping genes, at cost of increasing the false positive rate.

# Define a function to test whether the overlap of two sets of differentially expressed genes, 
# drawn from a common pool (e.g. all the orthologs that were tested), is higher or lower than expected
# Inspiration for this code: https://stats.stackexchange.com/questions/10328/using-rs-phyper-to-get-the-probability-of-list-overlap
overlap.hypergeometric.test <- function(n.overlaps, num.sig1, num.sig2, num.genes, species){
  p.smaller <- phyper(n.overlaps, num.sig1, num.genes - num.sig1, num.sig2) 
  p.higher <- 1 - phyper(n.overlaps - 1, num.sig1, num.genes - num.sig1, num.sig2)
  percent_of_maximum_overlaps <- 100 * n.overlaps / min(c(num.sig1, num.sig2))
  output <- data.frame(Species = species,
                       Test = c("Overlap is lower than expected:",
                                  "Overlap is higher than expected:"),
                       p = c(p.smaller, p.higher),
                       percent_of_maximum_overlaps = round(percent_of_maximum_overlaps,1))
  output[output$p == min(output$p), ]
}



# Apis and flavus
af.oggs <- make.OGGs(c("am", "lf"))[[2]] # Get the orthologous gene list
n.am <- (tbl(my_db, "ebseq_padj_gene_am") %>% 
           filter(gene %in% af.oggs$am) %>% 
           summarise(n=n()) %>% 
           as.data.frame())[1,1] # Count the number of diff expressed genes that appear in the OGG list
n.lf <- (tbl(my_db, "ebseq_padj_gene_lf") %>% 
           filter(gene %in% af.oggs$lf) %>% summarise(n=n()) %>% 
           as.data.frame())[1,1]
num.oggs.af <- nrow(af.oggs) # Count the orthologous genes
af.oggs <- suppressMessages(
  af.oggs %>% 
    filter(am %in% (tbl(my_db, "ebseq_padj_gene_am") %>% 
                      as.data.frame())[,1],
           lf %in% (tbl(my_db, "ebseq_padj_gene_lf") %>% 
                      as.data.frame())[,1]) %>% 
    mutate(Species = "Apis and L. flavus") %>% 
    left_join(tbl(my_db, "ebseq_gene_am") %>% 
                dplyr::select(gene, PostFC) %>% 
                rename(am=gene), copy=T) %>% 
    rename(`Apis FC` = PostFC) %>%
    left_join(tbl(my_db, "ebseq_gene_lf") %>% 
                dplyr::select(gene, PostFC) %>% 
                rename(lf=gene), copy=T) %>% 
    rename(`L. flavus FC` = PostFC) %>%
    left_join(tbl(my_db, "bee_names") %>% 
                rename(am=gene), copy=T))
num.overlap.af <- nrow(af.oggs) # Count the overlaps
test1 <- overlap.hypergeometric.test(num.overlap.af, 
                                     n.am, n.lf, 
                                     num.oggs.af, 
                                     "Apis and L. flavus") # Run the hypergeometric test


# Apis and niger
an.oggs <- make.OGGs(c("am", "ln"))[[2]] # Get the orthologous gene list
n.am <- (tbl(my_db, "ebseq_padj_gene_am") %>% 
           filter(gene %in% an.oggs$am) %>% 
           summarise(n=n()) %>% as.data.frame())[1,1] # Count the number of diff expressed genes that appear in the OGG list
n.ln <- (tbl(my_db, "ebseq_padj_gene_ln") %>% 
           filter(gene %in% an.oggs$ln) %>% 
           summarise(n=n()) %>% as.data.frame())[1,1]
num.oggs.an <- nrow(an.oggs) # Count the orthologous genes
an.oggs <- suppressMessages(
  an.oggs %>% 
    filter(am %in% (tbl(my_db, "ebseq_padj_gene_am") %>% as.data.frame())[,1],
           ln %in% (tbl(my_db, "ebseq_padj_gene_ln") %>% as.data.frame())[,1]) %>% 
    mutate(Species = "Apis and L. niger") %>% 
    left_join(tbl(my_db, "ebseq_gene_am") %>% 
                dplyr::select(gene, PostFC) %>% 
                rename(am=gene), copy=T) %>% 
    rename(`Apis FC` = PostFC) %>%
    left_join(tbl(my_db, "ebseq_gene_ln") %>% 
                dplyr::select(gene, PostFC) %>% 
                rename(ln=gene), copy=T) %>% 
    rename(`L. niger FC` = PostFC) %>%
    left_join(tbl(my_db, "bee_names") %>% 
                rename(am=gene), copy=T))
num.overlap.an <- nrow(an.oggs) # Count the overlaps
test2 <- overlap.hypergeometric.test(num.overlap.an, n.am, n.ln, num.oggs.an, "Apis and L. niger") # Run the hypergeometric test

# flavus and niger
fn.oggs <- make.OGGs(c("lf", "ln"))[[2]] # Get the orthologous gene list
n.lf <- (tbl(my_db, "ebseq_padj_gene_lf") %>% 
           filter(gene %in% fn.oggs$lf) %>%
           summarise(n=n()) %>% as.data.frame())[1,1] # Count the number of diff expressed genes that appear in the OGG list
n.ln <- (tbl(my_db, "ebseq_padj_gene_ln") %>% 
           filter(gene %in% fn.oggs$ln) %>% 
           summarise(n=n()) %>% as.data.frame())[1,1]
num.oggs.fn <- nrow(fn.oggs) # Count the orthologous genes
fn.oggs <- suppressMessages(
  fn.oggs %>% filter(ln %in% (tbl(my_db, "ebseq_padj_gene_ln") %>% as.data.frame())[,1],
                     lf %in% (tbl(my_db, "ebseq_padj_gene_lf") %>% as.data.frame())[,1]) %>% 
    mutate(Species = "L. flavus and L. niger") %>% 
    left_join(tbl(my_db, "ebseq_gene_lf") %>% 
                dplyr::select(gene, PostFC) %>% 
                rename(lf=gene), copy=T) %>% 
    rename(`L. flavus FC` = PostFC) %>%
    left_join(tbl(my_db, "ebseq_gene_ln") %>% 
                dplyr::select(gene, PostFC) %>% 
                rename(ln=gene), copy=T) %>% 
    rename(`L. niger FC` = PostFC) %>%
    left_join(tbl(my_db, "lf2am"), copy=T) %>%
    left_join(tbl(my_db, "bee_names") %>% 
                rename(am=gene), copy=T))
num.missing <- sum(is.na(fn.oggs$name))
fn.oggs$name[is.na(fn.oggs$name)] <- paste("Unknown gene", 1:num.missing)
num.overlap.fn <- nrow(fn.oggs) # Count the overlaps
test3 <- overlap.hypergeometric.test(num.overlap.fn, 
                                     n.lf, n.ln, 
                                     num.oggs.fn, 
                                     "L. flavus and L. niger") # Run the hypergeometric test


overlaps <- suppressMessages(
  data.frame(name = unique(c(af.oggs$name, an.oggs$name, fn.oggs$name)), 
             stringsAsFactors = F) %>%
    left_join(rbind(af.oggs %>% dplyr::select(name, starts_with("Apis")),
                    an.oggs %>% dplyr::select(name, starts_with("Apis")))) %>%
    left_join(rbind(af.oggs %>% dplyr::select(name, ends_with("flavus FC")),
                    fn.oggs %>% dplyr::select(name, ends_with("flavus FC")))) %>%
    left_join(rbind(an.oggs %>% dplyr::select(name, ends_with("niger FC")),
                    fn.oggs %>% dplyr::select(name, ends_with("niger FC")))) %>% distinct())
overlaps <- rbind(overlaps[overlaps$name == "myosin light chain alkali-like isoform X5", ],
                  overlaps[overlaps$name != "myosin light chain alkali-like isoform X5", ])
overlaps$Consistent <- "Yes"
overlaps$Consistent[apply(overlaps[,2:4],1,min,na.rm=T)<1 & apply(overlaps[,2:4],1,max,na.rm=T)>1] <- "No"
for(i in 2:4) overlaps[,i] <- format(round(log2(overlaps[,i]), 3), nsmall = 3) 
overlaps[overlaps == "    NA"] <- " "
rownames(overlaps) <- NULL

overlap.p.values <- rbind(test1, test2, test3) 
rownames(overlap.p.values) <- NULL

all.overlaps <- c(af.oggs$am, an.oggs$am, fn.oggs$am[!is.na(fn.oggs$am)]) %>% unique

Table S6: All orthologous genes that were significantly differentially expressed between pheromone treatments in more than one species. The FC columns give the Log\(_2\) fold-change in expression for each species where the focal gene was significantly differentially expressed, where positive numbers mean it was expressed at a higher level in control animals. The last column highlights genes that responded to treatment in a consistent or inconsistent direction across species. B. terrestris is omitted because neither of its differentially expressed genes were significantly affected by treatment in the other three species.

saveRDS(overlaps, file = "supplement/tab_S6.rds")
kable.table(overlaps)
name Apis FC L. flavus FC L. niger FC Consistent
myosin light chain alkali-like isoform X5 0.444 0.372 0.350 Yes
proteasome subunit beta type-5-like 0.484 -0.434 No
probable Bax inhibitor 1 0.447 -0.167 No
intracellular protein transport protein USO1 isoform X2 -0.684 0.445 No
muscle M-line assembly protein unc-89 isoform X5 -0.526 0.213 No
transitional endoplasmic reticulum ATPase TER94 0.544 -0.306 No
actin related protein 1 0.762 0.083 Yes
tubulin alpha-1 chain-like 0.773 -0.251 No
Unknown gene 1 -0.088 0.048 No
uncharacterized protein LOC100576760 isoform X2 -0.066 -0.163 Yes
myosin regulatory light chain 2 0.258 0.279 Yes
NADP-dependent malic enzyme isoform X3 0.040 -0.067 No
transketolase isoform 1 -0.248 -0.342 Yes
troponin T, skeletal muscle 0.374 0.185 Yes
uncharacterized protein LOC551958 0.511 -0.108 No
probable cytochrome P450 304a1 -0.224 0.470 No
Unknown gene 2 0.181 0.092 Yes
WD repeat-containing protein 37-like isoform X4 0.083 0.407 Yes
Unknown gene 3 -0.131 -0.211 Yes
uncharacterized protein LOC409805 isoform X3 0.444 0.415 Yes
ADP/ATP translocase 0.054 0.154 Yes
peroxidase isoformX2 0.104 0.008 Yes
neurofilament heavy polypeptide-like isoform X2 0.377 0.069 Yes
fatty acid synthase-like isoform 1 -0.926 -1.015 Yes
LOW QUALITY PROTEIN: counting factor associated protein D-like -0.294 -0.097 Yes
myophilin-like 0.226 0.216 Yes
Unknown gene 4 0.039 0.254 Yes
hexaprenyldihydroxybenzoate methyltransferase, mitochondrial-like 7.514 -0.368 No
arginine kinase isoform X2 0.441 0.141 Yes
heat shock protein cognate 4 -0.369 -0.432 Yes
tropomyosin-1-like 0.116 0.393 Yes
6-phosphogluconate dehydrogenase, decarboxylating -0.445 -0.603 Yes
transaldolase -0.044 0.034 No
superoxide dismutase 1 -0.175 -0.324 Yes
translation elongation factor 2-like isoform 1 -0.079 0.004 No
very-long-chain enoyl-CoA reductase-like -0.201 -0.431 Yes
Unknown gene 5 0.350 0.359 Yes



Table S7: The overlap between the lists of significantly differently expressed orthologous genes was significantly higher than expected for L. flavus and L. niger, suggesting that queen pheromone has conserved effects on gene expression between these two species (results based on a hypergeometric test). For the other two species pairs, the number of overlapping genes was not higher or lower than expected under the null hypothesis that queen pheromone affects a random set of genes in each species. The last column gives the number of genes that overlapped, divided by the maximum number that could have overlapped given the numbers of orthologous genes that were significant in each species.

names(overlap.p.values)[4] <- "% of maximum possible overlap" 
saveRDS(overlap.p.values, file = "supplement/tab_S7.rds")
pander(overlap.p.values, split.cell = 40, split.table = Inf)
Species Test p % of maximum possible overlap
Apis and L. flavus Overlap is higher than expected: 0.1915 5.8
Apis and L. niger Overlap is higher than expected: 0.2616 6.1
L. flavus and L. niger Overlap is higher than expected: 0 42.3
most.pheromone.sensitive.genes <- function(){
  ngenes.list <- (1:5)*100 # 100 - 500
  
  overlapping_genes <- list()
  permutation_results <- list()
  for(i in 1:length(ngenes.list)){
    ngenes <- ngenes.list[i]
    
    # Get the top n genes from Apis, as ranked by the absolute value for the log-fold change in response to pheromone
    g1 <- tbl(my_db, "ebseq_gene_am") %>% collect() %>% 
      dplyr::select(gene, PostFC) %>% 
      mutate(PostFC = log2(PostFC)) %>% left_join(tbl(my_db, "bee_names"), copy=TRUE, by = "gene") %>% 
      arrange(-abs(PostFC)) 
    
    # Do the same for genes from non-Apis species, and get the Apis names for the top BLAST hits in the Apis genome
    g2 <- tbl(my_db, "ebseq_gene_bt") %>% 
      dplyr::select(gene, PostFC) %>% 
      left_join(tbl(my_db, "bt2am") %>% 
                  rename(gene = bt) %>% 
                  dplyr::select(-evalue), by = "gene") %>%
      collect() %>% mutate(PostFC = log2(PostFC)) %>% 
      arrange(-abs(PostFC)) %>% 
      rename(bt = gene, gene = am) %>% 
      left_join(tbl(my_db, "bee_names"), copy=TRUE, by = "gene") %>% 
      filter(!is.na(name)) 
    
    g3 <- tbl(my_db, "ebseq_gene_lf") %>% 
      dplyr::select(gene, PostFC) %>% 
      left_join(tbl(my_db, "lf2am") %>% 
                  rename(gene = lf) %>% 
                  dplyr::select(-evalue), by = "gene") %>%
      collect() %>% mutate(PostFC = log2(PostFC)) %>% 
      arrange(-abs(PostFC)) %>% 
      rename(lf = gene, gene = am) %>% 
      left_join(tbl(my_db, "bee_names"), copy=TRUE, by = "gene") %>% 
      filter(!is.na(name)) 
    
    g4 <-tbl(my_db, "ebseq_gene_ln") %>% 
      dplyr::select(gene, PostFC) %>% 
      left_join(tbl(my_db, "ln2am") %>% 
                  rename(gene = ln) %>% 
                  dplyr::select(-evalue), by = "gene") %>%
      collect() %>% mutate(PostFC = log2(PostFC)) %>% 
      arrange(-abs(PostFC)) %>% 
      rename(ln = gene, gene = am) %>% 
      left_join(tbl(my_db, "bee_names"), copy=TRUE, by = "gene") %>% 
      filter(!is.na(name)) 
    
    get_top <- function(x, ngenes) {x %>% head(ngenes) %>% .$name %>% unique()}
    
    # Count the number of intersections, and find gene names that appear in 3 or 4 species using the venn() function
    venn.diagram <- venn(list(am=(g1 %>% get_top(ngenes)), 
                              bt=(g2 %>% get_top(ngenes)), 
                              lf=(g3 %>% get_top(ngenes)), 
                              ln=(g4 %>% get_top(ngenes))), show.plot=FALSE) 
    three.plus <- attr(venn.diagram, "intersections")[str_count(names(attr(venn.diagram, "intersections")), ":") > 1] %>% 
      unlist %>% unname %>% unique %>% sort
    four <- attr(venn.diagram, "intersections")[str_count(names(attr(venn.diagram, "intersections")), ":") > 2] %>% 
      unlist %>% unname %>% unique %>% sort
    three <- three.plus[!(three.plus %in% four)]
    if(length(three) + length(four) > 0) overlapping_genes[[i]] <- data.frame(Name = c(three, four), 
                                                                              count = c(rep("x3 species", length(three)), 
                                                                                        rep("4 species", length(four))), 
                                                                              nGenes = ngenes, stringsAsFactors = FALSE)
    
    count_intersects <- function(l1, l2) {
      
      intersections <- attr(venn(list(am=l1 %>% get_top(ngenes), 
                                      bt=l2 %>% get_top(ngenes)), 
                                 show.plot=FALSE), "intersections")
      if(length(intersections) > 2) return(length(intersections[[3]]))
      else return(0)
      
    }
    
    # permutation test
    num_overlaps <- c(count_intersects(g1,g2), count_intersects(g1,g3), count_intersects(g1,g4),
                      count_intersects(g2,g3), count_intersects(g2,g4), count_intersects(g3,g4))
    
    nBoots <- 10000
    boot_results <- lapply(1:nBoots, function(x){
      g1 <- g1[sample(nrow(g1), nrow(g1)), ]
      g2 <- g2[sample(nrow(g2), nrow(g2)), ]
      g3 <- g3[sample(nrow(g3), nrow(g3)), ]
      g4 <- g4[sample(nrow(g4), nrow(g4)), ]
      
      c(count_intersects(g1,g2), count_intersects(g1,g3), count_intersects(g1,g4),
        count_intersects(g2,g3), count_intersects(g2,g4), count_intersects(g3,g4))
      
    }) %>% do.call("rbind", .) 
    
    p <- 1:6
    for(j in 1:6) p[j] <- sum(boot_results[,j] > num_overlaps[j]) / nBoots
    
    permutation_results[[i]] <- tibble(species_pair = c("am-bt", "am-lf", "am-ln", "bt-lf", "bt-ln", "lf-ln"),
                                       top_n_genes = ngenes.list[i],
                                       observed_overlaps = num_overlaps,
                                       expected_overlaps = colMeans(boot_results),
                                       `O/E` = observed_overlaps / expected_overlaps,
                                       p = p,
                                       x = ifelse(p < 0.05, "sig", " ")) %>% as.data.frame()
  } # end of for()

  permutation_results <- do.call("rbind", permutation_results)
  names(permutation_results) <- c("Species pair", "Size of gene set", "Obs. overlaps", "Exp. overlaps", "O/E", "p-value", "")
  
  overlapping_genes <- do.call("rbind", overlapping_genes) %>%
    arrange(count, nGenes, Name) %>%
    distinct(paste(Name, count), .keep_all = TRUE) %>%
    dplyr::select(Name, count, nGenes) %>%
    mutate(count = replace(count, count == "x3 species", "3 species")) 
  
  names(overlapping_genes) <- c("Name", "Appears in", "Size of gene set")
  list(overlapping_genes, permutation_results)
}

if(!("most.pheromone.sensitive.genes.rds" %in% list.files("data"))){
  most.pheromone.sensitive.genes <- most.pheromone.sensitive.genes()
  saveRDS(most.pheromone.sensitive.genes, "data/most.pheromone.sensitive.genes.rds")
} else {
  most.pheromone.sensitive.genes <- readRDS("data/most.pheromone.sensitive.genes.rds")
}

Table S8: List of genes that appear in the top n-most pheromone-sensitive genes for 3 or 4 species. To generate the table, we ranked genes by the absolute value of their log fold change in response to queen pheromone, then listed the gene names that appeared in 3-4 species. For non-Apis species, we found the gene names by comparison with the Apis genome by BLAST. This exercise was performed with n = 100, 200 … 500, and the third column lists the smallest n for which the gene in question appeared (for example, the gene protein takeout-like appeared for all 4 species when inspecting the top 200+ genes).

saveRDS(most.pheromone.sensitive.genes[[1]], file = "supplement/tab_S8.rds")
kable(most.pheromone.sensitive.genes[[1]], "html") %>%
  kable_styling() %>%
  scroll_box(height = "300px")
Name Appears in Size of gene set
protein takeout-like 4 species 200
glucose dehydrogenase [FAD, quinone] 4 species 300
histone-lysine N-methyltransferase SETMAR-like 4 species 300
serotonin receptor 4 species 500
titin-like 4 species 500
uncharacterized protein LOC102656088 4 species 500
histone-lysine N-methyltransferase SETMAR-like 3 species 200
2-oxoglutarate dehydrogenase, mitochondrial-like isoform X5 3 species 300
probable serine/threonine-protein kinase DDB_G0282963 isoform X4 3 species 300
titin-like 3 species 300
elongation of very long chain fatty acids protein 6-like 3 species 400
ligand-gated chloride channel homolog 3 precursor 3 species 400
odorant receptor Or2-like 3 species 400
putative odorant receptor 13a-like 3 species 400
serotonin receptor 3 species 400
trypsin-1 3 species 400
uncharacterized protein LOC100576902 3 species 400
uncharacterized protein LOC102655422 3 species 400
uncharacterized protein LOC102656088 3 species 400
metabotropic glutamate receptor 7 isoform X3 3 species 500
probable cytochrome P450 305a1 3 species 500
protein NPC2 homolog 3 species 500
suppressor protein SRP40-like 3 species 500
uncharacterized protein LOC100577132 3 species 500
uncharacterized protein LOC102656830 3 species 500
uncharacterized protein LOC724216 3 species 500



Table S9: Results of a permutation test examining the number of overlaps in the top n-most pheromone-sensitive genes for each pair of species. To generate the table, we ranked genes by the absolute value of their log fold change in response to queen pheromone, then took the top n-most pheromone-sensitive genes for each species, and counted the observed and expected number of overlaps (the expected number was estimated by bootstrapping with 10^5 replicates). The O/E column gives the ratio of observed to expected, where numbers >1 indicate more overlap than expected. The one-tailed p-value was estimated as the proportion of bootstrap replicates showing more overlap than in the real dataset. This exercise was performed with n = 100, 200 … 500.

saveRDS(most.pheromone.sensitive.genes[[2]], file = "supplement/tab_S9.rds")
kable(most.pheromone.sensitive.genes[[2]], "html", digits=2) %>%
  kable_styling() %>%
  scroll_box(height = "300px")
Species pair Size of gene set Obs. overlaps Exp. overlaps O/E p-value
am-bt 100 1 0.97 1.03 0.25
am-lf 100 2 0.97 2.07 0.07
am-ln 100 2 0.99 2.03 0.08
bt-lf 100 1 1.61 0.62 0.48
bt-ln 100 4 1.65 2.42 0.02 sig
lf-ln 100 6 2.28 2.63 0.01 sig
am-bt 200 8 3.83 2.09 0.02 sig
am-lf 200 3 3.79 0.79 0.53
am-ln 200 2 3.82 0.52 0.74
bt-lf 200 4 6.37 0.63 0.77
bt-ln 200 14 6.59 2.13 0.00 sig
lf-ln 200 14 8.62 1.62 0.02 sig
am-bt 300 18 8.52 2.11 0.00 sig
am-lf 300 6 8.31 0.72 0.74
am-ln 300 8 8.50 0.94 0.48
bt-lf 300 13 14.20 0.92 0.56
bt-ln 300 28 14.67 1.91 0.00 sig
lf-ln 300 26 18.38 1.41 0.03 sig
am-bt 400 27 15.00 1.80 0.00 sig
am-lf 400 10 14.64 0.68 0.88
am-ln 400 19 14.88 1.28 0.11
bt-lf 400 24 24.99 0.96 0.53
bt-ln 400 47 25.74 1.83 0.00 sig
lf-ln 400 38 31.27 1.22 0.08
am-bt 500 36 23.18 1.55 0.00 sig
am-lf 500 16 22.60 0.71 0.91
am-ln 500 22 22.90 0.96 0.52
bt-lf 500 42 38.48 1.09 0.24
bt-ln 500 62 39.72 1.56 0.00 sig
lf-ln 500 58 47.09 1.23 0.04 sig

Pheromone-sensitive genes tend to be evolutionarily ancient

We defined a gene as “evolutionarily ancient” if it has an ortholog in at least one species from the other lineage (for example, we define ancient A. mellifera genes as those that have a reciprocal best BLAST hit in at least one of the Lasius ant species). Genes that were not detected by BLAST in the other lineage were defined as putatively lineage-specific (though many of them are likely to be conserved genes that we failed to identify as such, hence the word “putative”). Using a non-parametric Mann-Whitney test, we show that the average pheromone sensitivity of ancient genes is significantly lower than that of non-ancient genes, for all 4 species (p < 0.0001). Note that we have probably misclassifed some genes as ancient or lineage-specific, which means that the result might be even stronger than suggested here.

ancient.genes.test <- function(species){   
  if(species == "am") ancient.genes <- c(make.OGGs(c("am", "lf"))[[2]]$am, 
                                         make.OGGs(c("am", "ln"))[[2]]$am) %>% unique
  if(species == "bt") ancient.genes <- c(make.OGGs(c("bt", "lf"))[[2]]$bt, 
                                         make.OGGs(c("bt", "ln"))[[2]]$bt) %>% unique
  if(species == "lf") ancient.genes <- c(make.OGGs(c("lf", "am"))[[2]]$lf, 
                                         make.OGGs(c("lf", "bt"))[[2]]$lf) %>% unique
  if(species == "ln") ancient.genes <- c(make.OGGs(c("ln", "am"))[[2]]$ln, 
                                         make.OGGs(c("ln", "bt"))[[2]]$am) %>% unique
  
  dat <- tbl(my_db, paste("ebseq_gene_", species, sep="")) %>%
    collect(n = Inf) %>%
    mutate(Ancient = "No",
           Ancient = replace(Ancient, gene %in% ancient.genes, "Yes"),
           sensitivity = abs(log(PostFC))) %>%
    select(Ancient, sensitivity) 
  
  ancient.genes <- dat$sensitivity[dat$Ancient == "Yes"]
  
  if(species %in% c("lf", "ln")) {
    Putatively.ant.specific.genes <- dat$sensitivity[dat$Ancient == "No"]
    print(wilcox.test(ancient.genes, Putatively.ant.specific.genes)) 
  }
  else {
    Putatively.bee.specific.genes <- dat$sensitivity[dat$Ancient == "No"]
    print(wilcox.test(ancient.genes, Putatively.bee.specific.genes)) 
  }
  
  dat %>% 
    group_by(Ancient) %>% 
    summarise(Mean_pheromone_sensitivity = mean(sensitivity), SE = sd(sensitivity) / sqrt(length(sensitivity))) %>% pander()
}

Apis mellifera

ancient.genes.test("am") 

    Wilcoxon rank sum test with continuity correction

data:  ancient.genes and Putatively.bee.specific.genes
W = 13256000, p-value < 2.2e-16
alternative hypothesis: true location shift is not equal to 0
Ancient Mean_pheromone_sensitivity SE
No 0.39 0.004841
Yes 0.2368 0.002991

Bombus terrestris

ancient.genes.test("bt") 

    Wilcoxon rank sum test with continuity correction

data:  ancient.genes and Putatively.bee.specific.genes
W = 8329700, p-value < 2.2e-16
alternative hypothesis: true location shift is not equal to 0
Ancient Mean_pheromone_sensitivity SE
No 0.2277 0.005443
Yes 0.1084 0.001806

Lasius flavus

ancient.genes.test("lf")  

    Wilcoxon rank sum test with continuity correction

data:  ancient.genes and Putatively.ant.specific.genes
W = 74676000, p-value < 2.2e-16
alternative hypothesis: true location shift is not equal to 0
Ancient Mean_pheromone_sensitivity SE
No 0.316 0.001468
Yes 0.1269 0.002151

Lasius niger

ancient.genes.test("ln")  

    Wilcoxon rank sum test with continuity correction

data:  ancient.genes and Putatively.ant.specific.genes
W = 23871000, p-value < 2.2e-16
alternative hypothesis: true location shift is not equal to 0
Ancient Mean_pheromone_sensitivity SE
No 0.1761 0.00145
Yes 0.1004 0.001726

Correlations in pheromone-sensitive gene expression across species

These tests ask if pairs of orthologous genes tend to show a similar level of pheromone sensitivity across species. These tests ask whether there is a cross-species correlation in absolute log fold change in response to pheromone treatment, as calculated using ebseq. The advantage of these tests is that one is not limited to focusing on the set of ‘significant’ genes (as with the Venn diagrams shown in Figure 1), which discards a lot of information becuase it uses an arbitrary p-value threshold, and puts all the genes into two bins (ignoring the quantitative differences in fold-change).

Define function to retrieve fold-change expression data (calculated with ebseq) for genes that are each other’s reciprocal best BLAST

get.fc.for.pair.species <- function(species1, species2){
  query <- 'SELECT rbb.X AS X_gene, rbb.Y AS Y_gene, ebseq_gene_X.PostFC AS X_fc, ebseq_gene_Y.PostFC AS Y_fc FROM ebseq_gene_X
             JOIN
  (SELECT Y2X.X, Y2X.Y  FROM Y2X
  JOIN X2Y
  ON Y2X.Y = X2Y.Y AND Y2X.X = X2Y.X  ) AS rbb
  ON rbb.X = ebseq_gene_X.gene
  JOIN ebseq_gene_Y
  ON rbb.Y = ebseq_gene_Y.gene'
  
  query <- str_replace_all(query, "X", species1)
  query <- str_replace_all(query, "Y", species2)
  dbGetQuery(db, query)
}

Make a table and some plots of the correlations for each pair of species

Table S10: Results of Spearman’s rank correlations, testing whether the absolute log fold difference between pheromones treatments is correlated for a given pair of species. Positive coefficients (\(\rho\), written as rho) indicate that on average, orthologous genes have similar sensitivity to queen pheromones. The p-values have been corrected for multiple testing with the Benjamini-Hochberg method.

species.combinations <- t(combn(c("am", "bt", "lf", "ln"), 2))
rho <- numeric(nrow(species.combinations))
p <- numeric(nrow(species.combinations))
for(i in 1:nrow(species.combinations)){
  fc.data <- get.fc.for.pair.species(species.combinations[i, 1], 
                                     species.combinations[i, 2])
  fc.data[,3:4] <- fc.data[,3:4] %>% log2 %>% abs # Log the fold changes - not that it matters for Spearman's!
  results <- suppressWarnings(with(fc.data, cor.test(fc.data[,3], 
                                                     fc.data[,4], method="spearman"))) # Spearman's correlation
  rho[i] <- results$estimate
  p[i] <- results$p.value
}

species.combinations <- data.frame(Species1 = species.combinations[,1],
                                   Species2  = species.combinations[,2],
                                   rho = rho,
                                   p = p.adjust(p, method = "BH"), # adjust these p-vals for multiple testing
                                   sig = " ", stringsAsFactors = F)

species.combinations[species.combinations == "am"] <- "Apis mellifera"
species.combinations[species.combinations == "bt"] <- "Bombus terrestris"
species.combinations[species.combinations == "lf"] <- "Lasius flavus"
species.combinations[species.combinations == "ln"] <- "Lasius niger"

species.combinations$sig[species.combinations$p < 0.05] <- "*"
species.combinations$sig[species.combinations$p < 0.01] <- "**"
species.combinations$sig[species.combinations$p < 0.0001] <- "***"
# Make a table
saveRDS(species.combinations %>% mutate(rho = format(round(rho, 3), nsmall = 3)), file = "supplement/tab_S10.rds")
species.combinations %>% mutate(rho = format(round(rho, 3), nsmall = 3)) %>% pander
Species1 Species2 rho p sig
Apis mellifera Bombus terrestris 0.136 3.232e-24 ***
Apis mellifera Lasius flavus 0.100 1.478e-12 ***
Apis mellifera Lasius niger 0.077 1.853e-07 ***
Bombus terrestris Lasius flavus 0.159 3.112e-39 ***
Bombus terrestris Lasius niger 0.127 2.282e-24 ***
Lasius flavus Lasius niger 0.194 3.765e-61 ***
# Make a heat map showing the correlations
heat.map.figure <- species.combinations %>% ggplot(aes(Species1, Species2, fill=rho)) + 
  geom_tile(colour="white", size = 4) + 
  scale_fill_gradient2(name = "Corr", 
                       low = brewer.pal(9, "RdYlBu")[7], 
                       mid = "white", 
                       high = brewer.pal(9, "RdYlBu")[2]) + 
  geom_text(aes(label = paste(format(signif(rho, 2), nsmall = 2), sig)), size = 3.5) +
  theme_bw() + theme(panel.grid = element_blank(), 
                     panel.border = element_blank(), 
                     axis.ticks = element_blank(), 
                     axis.text = element_text(face = "italic"), 
                     legend.position = "none") + 
  xlab(NULL) + ylab(NULL) +
  scale_x_discrete(labels = c("Apis\nmellifera", "Bombus\nterrestris", "Lasius\nflavus"), expand = c(0,0)) + 
  scale_y_discrete(labels = c("Bombus\nterrestris", "Lasius\nflavus", "Lasius\nniger"), expand = c(0,0)) 
heat.map.figure

Version Author Date
f260a62 Luke Holman 2019-03-07
ggsave(heat.map.figure, file = "figures/Correlations heat map.pdf", height = 4, width=4.3)
# Make a scatterplot showing the correlations
combos <- t(combn(c("am", "bt", "lf", "ln"), 2))
scatter_plot_data <- list()

for(i in 1:nrow(combos)){
  fc.data <- get.fc.for.pair.species(combos[i, 1], 
                                     combos[i, 2])
  fc.data <- fc.data[,3:4] %>% log2 %>% abs # Log the fold changes
  names(fc.data) <- c("x", "y")
  scatter_plot_data[[i]] <- data.frame(fc.data, sp1 = species.combinations[i, 1], sp2 = species.combinations[i, 2])
}

fig_S3 <- scatter_plot_data %>% 
  do.call("rbind", .) %>% 
  ggplot(aes(x, y)) + 
  geom_point(alpha = 0.15) +
  stat_smooth(method = "lm", colour = "tomato") +
  facet_wrap(~paste(sp1, sp2, sep = " v "), scales = "free", ncol = 2) + 
  labs(x = "Pheromone sensitivity of ortholog in species 1",
       y = "Pheromone sensitivity of ortholog in species 2") + 
  theme_minimal()

saveRDS(fig_S3, file = "supplement/fig_S3.rds")
fig_S3

Version Author Date
f260a62 Luke Holman 2019-03-07



Figure S3: Each scatterplot shows the correlation in pheromone sensitivity across pairs of orthologous genes, for each of the six possible species pairs. Species 1 refers to the first-listed species, such that in the top-left panel, Apis mellifera is plotted on the x-axis and Bombus terrestris is on the y-axis. The regression lines are from a simple linear regression, and the grey zone around the line shows its 95% confidence intervals.

Identifying genes that splice differently following queen pheromone treatment

Many genes showed alternative splicing in all four species, with the great majority showing between 1 and 6 isoforms.

fig_S4 <- rbind(my_db %>% tbl("isoforms_am") %>% collect %>% .$gene %>%
        table %>% melt %>% dplyr::select(value) %>% mutate(sp = "Apis mellifera"),
      my_db %>% tbl("isoforms_bt") %>% collect %>% .$gene %>%
        table %>% melt %>% dplyr::select(value) %>% mutate(sp = "Bombus terrestris"),
      my_db %>% tbl("isoforms_lf") %>% collect %>% .$gene %>%
        table %>% melt %>% dplyr::select(value) %>% mutate(sp = "Lasius niger"),
      my_db %>% tbl("isoforms_ln") %>% collect %>% .$gene %>%
        table %>% melt %>% dplyr::select(value) %>% mutate(sp = "Lasius flavus")) %>%
  as.data.frame() %>%
  ggplot(aes(x = value, y = sp, fill = sp)) +
  geom_joy(stat = "binline", binwidth=1) +
  coord_cartesian(xlim=c(1,12)) +
  scale_fill_cyclical(values = c("#4040B0", "#9090F0")) +
  scale_x_continuous(breaks = seq(1,12,by=1)) +
  scale_y_discrete(expand = c(0.01, 0)) +
  theme_joy() +
  xlab("Number of isoforms") + ylab(NULL) +
  theme(axis.text = element_text(face = "italic"))

saveRDS(fig_S4, file = "supplement/fig_S4.rds")
fig_S4

Version Author Date
f260a62 Luke Holman 2019-03-07



Figure S4: Distribution of isoform numbers per gene for each of the four species.

# Define a function to search for significantly alternatively spliced genes. We define these as genes that have at least two differentially expressed isoforms, where queen pheromone stimulates expresison of one isoform but surpresses expression of another
find.alternatively.spliced.genes <- function(species){

  # Write a database query with 'X' as a placeholder for the species name
  # We want to find genes in which at least two isoforms are differentially expressed in response to pheromones
  # Significant isoforms are listed in the ebseq_padj_isoform_X tables, so we count them and get the names of their genes
  query <- 'SELECT isoforms_X.gene, isoforms_X.isoform, PostFC FROM isoforms_X
JOIN
             (SELECT gene, COUNT(*) FROM ebseq_padj_isoform_X
             JOIN isoforms_X
             ON isoforms_X.isoform = ebseq_padj_isoform_X.isoform
             GROUP BY gene
             HAVING COUNT(*)>1 ) AS multiISO
             ON multiIso.gene = isoforms_X.gene
             JOIN ebseq_padj_isoform_X
             ON ebseq_padj_isoform_X.isoform = isoforms_X.isoform
             ORDER BY isoforms_X.gene'
  query <- str_replace_all(query, "X", species) # replace X with the species
  Splice <- dbGetQuery(db, query) # run the query

  # Find the highest and lowest fold change for the isoforms of each gene
  SpliceMin <- aggregate(Splice$PostFC, by=list(Splice$gene), FUN="min")
  SpliceMax <- aggregate(Splice$PostFC, by=list(Splice$gene), FUN="max")
  SpliceCompare <- merge(SpliceMin, SpliceMax, by = "Group.1")
  colnames(SpliceCompare) <- c("gene", "min", "max")

  # Define diff-spliced genes as those with both elevated and
  # repressed isoforms, when comparing control and pheromone-treated workers
  output <- data.frame(gene = SpliceCompare$gene[SpliceCompare$min < 1 & SpliceCompare$max > 1], stringsAsFactors = F)

  # Add the Apis mellifera ortholog, from one-way BLAST, if it's a non-Apis species
  if(species != "am"){
    orthologs <- tbl(my_db, paste(species, "2am", sep = "")) %>% select(-evalue) %>% collect(n=Inf) %>% as.data.frame()
    names(orthologs) <- c("gene", "Amel_ortholog")
    output <- left_join(output, orthologs, by = "gene")
    output <- left_join(output, tbl(my_db, "bee_names") %>%
                          rename(Amel_ortholog = gene), copy=T, by = "Amel_ortholog")
  }
  else output <- left_join(output, tbl(my_db, "bee_names"), by = "gene", copy = T)

  output[is.na(output)] <- " "

  # Remove the 'isoform X' part from the gene name, so it gives the name of the gene not the isoform
  output$name <- unlist(lapply(strsplit(output$name, split = " isoform "), function(x) x[1]))

  output <- left_join(output, SpliceCompare, by = "gene")

  output$min <- log2(output$min) # Log2 transform the fold changes
  output$max <- log2(output$max)
  output <- output %>% arrange(-(abs(min) + max)) # Arrange by effect size

  if(species == "am" | species == "bt") names(output) <- c("Gene", "Name", "Lowest FC", "Highest FC")
  else names(output) <- c("Gene", "Amel ortholog", "Name", "Lowest FC", "Highest FC")
  output
}

Genes showing significant pheromone-induced alternative splicing

There were no genes showing significant pheromone-sensitive splicing for B. terrestris, hence this section contains only three tabs.

A. mellifera

Table S11: List of genes showing statistically significant pheromone-induced alternative splicing in A. mellifera. These genes were defined as those that have at least two isoforms that are differentially expressed following pheromone treatment (EBseq; posterior probability of differential expression p < 0.05), and for which one isoform increases in expression while another decreases. The last two columns show the fold changes of the most down-regulated and most up-regulated isoforms, on a Log\(_2\) scale.

am.alt.splice <- find.alternatively.spliced.genes("am")
saveRDS(am.alt.splice, file = "supplement/tab_S11.rds")
kable.table(am.alt.splice)
Gene Name Lowest FC Highest FC
GB44254 uncharacterized protein LOC411586 -10.2106382 7.3294705
GB55598 troponin I -8.6184698 7.4257311
GB55650 ryanodine receptor 44F -8.6521541 6.1211069
GB42000 cAMP-specific 3’,5’-cyclic phosphodiesterase, isoforms N/G -7.8461925 6.4652082
GB49567 sestrin-1-like isoformX1 -6.7384430 6.3303655
GB46113 uncharacterized protein LOC726188 -6.7215768 6.2049532
GB55237 disco-interacting protein 2 -6.4126080 5.7870758
GB44556 uncharacterized protein LOC411962 -5.3193508 6.4264182
GB50923 serine-protein kinase ATM -5.4981139 6.1549064
GB50941 phosphatidate phosphatase LPIN2-like -6.1378916 5.3694436
GB55848 DNA ligase 1-like -6.0254223 5.3645877
GB42142 nuclear hormone receptor FTZ-F1 -6.0475859 5.2543590
GB45259 zinc finger protein 91-like -5.7141149 5.4922565
GB52595 zinc finger and BTB domain-containing protein 20-like -6.0058327 5.1479879
GB55225 sushi, von Willebrand factor type A, EGF and pentraxin domain-containing protein 1 -3.5827048 7.3608415
GB55102 F-box only protein 28-like -5.6780118 5.1328776
GB42895 trichohyalin-like -6.0749616 4.6900449
GB44373 protein zyg-11 homolog B-like -2.7153166 7.8600431
GB49111 neuropathy target esterase sws -1.8617078 8.3596119
GB46271 protein BCL9 homolog -3.1471390 6.9356291
GB53431 inositol hexakisphosphate kinase 2-like -6.3417004 3.3365701
GB44336 protein couch potato-like -2.1830854 7.3541749
GB45277 multidrug resistance-associated protein 4-like -8.1135336 1.3365168
GB40263 dentin sialophosphoprotein-like -3.0597817 6.2723878
725417 uncharacterized protein LOC725417 -2.8308639 6.1603441
GB55517 uncharacterized protein LOC410000 -3.2763532 5.3768010
GB55429 CREB-regulated transcription coactivator 1-like -5.3728279 3.1844409
GB55998 beta-1,4-N-acetylgalactosaminyltransferase bre-4 -2.7284140 5.5956924
GB52604 LIM domain-binding protein 2-like -2.2872276 5.8679044
GB41734 reversion-inducing-cysteine-rich protein with kazal motifs -5.9697261 1.9393374
GB49535 calcium/calmodulin-dependent protein kinase II -1.9949124 5.8059893
GB45662 conserved oligomeric Golgi complex subunit 4-like -5.3583810 2.1410794
GB40310 uncharacterized protein LOC411575 -0.9447237 6.4575407
GB51117 rho GTPase-activating protein 18-like -0.9711563 6.3563951
GB41129 protein LMBR1L-like -5.6199019 1.4425609
GB44876 uncharacterized protein LOC100576421 -5.3652303 1.6410521
GB50244 NHL repeat-containing protein 2 -0.9371409 5.9580141
GB47138 calcium-activated potassium channel slowpoke-like -0.9035332 5.9504672
GB50099 uncharacterized abhydrolase domain-containing protein DDB_G0269086-like -1.5085077 5.0811380
GB41908 PERQ amino acid-rich with GYF domain-containing protein CG11148-like -1.0050181 5.5164280
GB52999 neurofilament heavy polypeptide-like -2.7388052 3.6790149
GB51651 putative inorganic phosphate cotransporter-like -5.4170376 0.9305746
GB50877 tyrosine-protein kinase Dnt -2.5061716 3.1568560
GB43220 transcription termination factor 2 -3.2229375 1.8337147
GB40565 ribosomal protein S6 kinase alpha-5 -2.3132702 2.6623092
GB55467 neural cell adhesion molecule L1-like -3.3341247 1.4565432
GB48034 protein numb-like, transcript variant X5 -1.0127583 3.7699557
GB55570 transmembrane protein 53-like -2.0692979 2.6556081
GB49417 PITH domain-containing protein GA19395-like -2.1836294 2.2457448
GB43282 guanine nucleotide-binding protein G(q) subunit alpha-like -2.3600303 2.0113196
GB48573 probable multidrug resistance-associated protein lethal(2)03659-like -2.1285308 1.9867141
GB50366 uncharacterized protein LOC551450 -0.8408050 1.1435481
GB46121 ubiquitin fusion degradation protein 1 homolog -0.9511837 0.9182434
GB52052 venom carboxylesterase-6-like -0.7021931 0.9102424

L. flavus

Table S12: List of genes showing statistically significant pheromone-induced alternative splicing in Lasius flavus. These genes were defined as those that have at least two isoforms that are differentially expressed following pheromone treatment (EBseq; posterior probability of differential expression p < 0.05), and for which one isoform increases in expression while another decreases. The last two columns show the fold changes of the most down-regulated and most up-regulated isoforms, on a Log\(_2\) scale.

lf.alt.splice<- find.alternatively.spliced.genes("lf")
saveRDS(lf.alt.splice, file = "supplement/tab_S12.rds")
kable.table(lf.alt.splice)
Gene Amel ortholog Name Lowest FC Highest FC
TRINITY_DN11346_c0_g1 GB49250 heme oxygenase -9.1733822 4.2807355
TRINITY_DN14030_c0_g1 XP_016769715.1 -4.5698062 6.1058670
TRINITY_DN13728_c1_g1 GB44606 AMP deaminase 2-like -5.6147192 4.2278104
TRINITY_DN13759_c0_g1 XP_016766389.1 -3.7805082 5.5650278
TRINITY_DN13897_c0_g1 GB41293 histone acetyltransferase KAT8 -4.6420034 2.6858828
TRINITY_DN14126_c1_g2 GB43039 restin homolog -1.8789713 5.3598354
TRINITY_DN12581_c0_g2 XP_016767063.1 -4.1075789 2.7973408
TRINITY_DN14084_c0_g1 XP_016772396.1 -2.4056262 4.1607373
TRINITY_DN13929_c0_g1 GB53852 paired amphipathic helix protein Sin3a -2.0878837 4.4200505
TRINITY_DN13956_c0_g1 GB54341 RNA-binding protein 33-like -1.9836823 4.5150571
TRINITY_DN13699_c0_g1 GB41835 sorting nexin-13-like -2.5195188 3.9141700
TRINITY_DN13676_c0_g1 XP_016767354.1 -3.9853775 2.2791646
TRINITY_DN13889_c0_g1 GB44338 small G protein signaling modulator 3 homolog -2.6671307 3.5553713
TRINITY_DN11861_c1_g1 GB43504 neural/ectodermal development factor IMP-L2 -2.2204311 3.4241368
TRINITY_DN14001_c0_g2 GB41033 facilitated trehalose transporter Tret1-like -3.4253663 2.1957523
TRINITY_DN12063_c0_g1 GB49936 calcium uptake protein 1 homolog, mitochondrial-like -1.9568877 3.6347798
TRINITY_DN13321_c0_g1 XP_016769905.1 -2.8397819 2.7402835
TRINITY_DN13931_c4_g1 GB47270 cytochrome P450 4C1 -2.2502914 2.8866039
TRINITY_DN12721_c1_g1 GB43391 transmembrane protein 8B-like -2.1793408 2.8228945
TRINITY_DN11401_c0_g1 GB50510 uncharacterized protein LOC409674 -2.6928098 1.9864175
TRINITY_DN10695_c0_g1 XP_016773356.1 -2.1193002 2.4882173
TRINITY_DN13698_c3_g1 GB45025 mTERF domain-containing protein 1, mitochondrial-like -1.9661074 2.5552928
TRINITY_DN13919_c0_g1 GB49593 cytosolic carboxypeptidase-like protein 5-like -1.6893918 2.7745341
TRINITY_DN14156_c10_g1 XP_016768402.1 -2.0840677 2.3753245
TRINITY_DN13974_c0_g1 XP_016768210.1 -1.5945919 2.7670315
TRINITY_DN12596_c0_g1 GB40801 thioredoxin-like protein 4A-like -1.7080464 2.3372385
TRINITY_DN13248_c0_g1 GB42981 beta-1,3-glucan-binding protein -1.6951844 2.3160927
TRINITY_DN14247_c8_g2 GB52590 fatty acid synthase-like -1.0570339 1.0113553
TRINITY_DN10832_c0_g1 GB54056 serine hydroxymethyltransferase, cytosolic -1.2534345 0.3609471
TRINITY_DN11786_c1_g1 GB51214 troponin T, skeletal muscle -0.4087698 0.8466319
TRINITY_DN13339_c0_g1 GB40735 fructose-bisphosphate aldolase-like -0.1714515 0.3993615
TRINITY_DN13721_c8_g1 XP_016772716.1 -0.2069941 0.2124566
TRINITY_DN13271_c0_g1 GB40312 choline/ethanolamine kinase-like -0.1549773 0.0102486
TRINITY_DN10322_c0_g1 XP_016769014.1 -0.1131430 0.0289235

L. niger

Table S13: List of genes showing statistically significant pheromone-induced alternative splicing in Lasius flavus. These genes were defined as those that have at least two isoforms that are differentially expressed following pheromone treatment (EBseq; posterior probability of differential expression p < 0.05), and for which one isoform increases in expression while another decreases. The last two columns show the fold changes of the most down-regulated and most up-regulated isoforms, on a Log\(_2\) scale.

ln.alt.splice <- find.alternatively.spliced.genes("ln")
saveRDS(ln.alt.splice, file = "supplement/tab_S13.rds")
kable.table(ln.alt.splice)
Gene Amel ortholog Name Lowest FC Highest FC
RF55_752 GB48208 protein argonaute-2 -3.2926101 6.4472781
RF55_883 XP_016770988.1 -5.9073798 3.5987463
RF55_4195 XP_016772612.1 -5.1744722 4.3092261
RF55_412 XP_016770021.1 -3.3875926 5.9670345
RF55_2523 XP_016770619.1 -4.7649090 4.0350580
RF55_3907 XP_016771611.1 -4.4508904 3.6861314
RF55_4516 GB54906 niemann-Pick C1 protein-like -3.7980002 4.3024830
RF55_2336 GB54910 tyrosine-protein kinase Abl-like -3.2249951 4.4534584
RF55_1192 XP_016769850.1 -1.9480198 5.7297004
XLOC_016164 -5.4972688 2.1282740
RF55_3254 XP_016773300.1 -2.7312184 4.8910736
RF55_1559 XP_016768510.1 -2.9908389 4.3225630
RF55_4335 XP_016767803.1 -3.8099604 3.4311823
RF55_6516 GB40718 thioredoxin reductase 1 -3.2537489 3.9222290
RF55_11163 GB53163 transient receptor potential channel pyrexia -3.9015904 3.2568624
RF55_1926 XP_016766364.1 -1.7898846 5.3146852
RF55_9605 GB42484 aminopeptidase N-like isoformX1 -5.0263823 2.0370079
XLOC_003165 -0.6701274 6.3901363
RF55_4472 GB43953 cycle -3.9049333 3.0344073
RF55_13096 XP_016767210.1 -4.8346835 2.0905931
RF55_9014 GB55507 FYVE, RhoGEF and PH domain-containing protein 4-like -3.9205477 2.9639182
RF55_8972 XP_016771571.1 -4.8894254 1.9830903
RF55_4341 XP_392463.4 -3.2324663 3.6096634
XLOC_013280 -2.4206648 4.3918399
RF55_2163 GB55475 cullin-5 -1.9499220 4.8473456
RF55_1574 XP_016770060.1 -0.5327703 6.2375585
RF55_6406 XP_016767146.1 -2.0553009 4.6650121
RF55_1819 GB51068 arrestin homolog -2.3004627 4.3994752
RF55_2357 XP_016769793.1 -4.9713497 1.7125669
RF55_2452 XP_016767413.1 -4.9414495 1.6803943
RF55_764 XP_001121384.4 -4.4683077 2.1308271
RF55_5343 XP_016766531.1 -3.3768061 3.2009350
RF55_2401 XP_016769193.1 -3.8965864 2.6724345
RF55_6625 XP_016770656.1 -2.0711259 4.4766181
RF55_4021 XP_016767419.1 -1.8167853 4.6555595
RF55_317 XP_016769975.1 -2.7140799 3.7123571
RF55_561 GB51542 PH-interacting protein -3.3596059 2.9952497
RF55_2755 GB48836 uncharacterized protein LOC100577578 -4.5392256 1.7981131
RF55_357 -4.0137355 2.2850079
RF55_9274 XP_016767607.1 -4.1097469 2.1003576
RF55_1902 GB46211 zinc finger protein 665-like -4.2211377 1.9522150
RF55_1336 XP_016767701.1 -4.2155289 1.9317851
RF55_1520 XP_016768717.1 -2.0486448 4.0217111
RF55_2217 GB47260 zinc finger protein 598-like -1.9608779 4.1054197
RF55_6360 XP_003251881.3 -3.5776193 2.4733234
RF55_15946 XP_016767569.1 -2.3204379 3.7235457
RF55_4138 XP_016766515.1 -2.3589464 3.6642057
RF55_1328 GB41746 neogenin -2.0301217 3.8766286
RF55_6748 GB52716 NAD kinase-like, transcript variant X11 -3.4936440 2.3932969
RF55_7315 GB55434 rab GDP dissociation inhibitor beta -3.1288936 2.7150106
RF55_9900 XP_016767864.1 -3.5513206 2.2796009
RF55_1325 GB44695 lysophospholipase-like protein 1-like -4.0976819 1.6743676
RF55_9036 XP_016768958.1 -3.9412444 1.7818052
RF55_742 XP_016769412.1 -2.7605014 2.9581890
RF55_9907 GB47039 dynamin -3.9896574 1.7131009
RF55_9185 XP_016768847.1 -3.8364223 1.8598316
RF55_2976 GB42054 sodium/potassium-transporting ATPase subunit alpha -2.0568520 3.6039514
RF55_4649 GB43618 aconitate hydratase, mitochondrial-like -5.0413696 0.5716779
RF55_12355 GB42664 probable ATP-dependent RNA helicase DDX43-like -1.9943294 3.6184641
RF55_1934 GB54827 synaptotagmin 1 -5.3908347 0.1905938
RF55_360 GB46768 uncharacterized MFS-type transporter C09D4.1-like -3.2312572 2.3204411
RF55_5123 XP_016772933.1 -2.7363919 2.8109308
RF55_3009 GB53317 dentin sialophosphoprotein-like -3.7638023 1.7787767
RF55_5073 GB55540 zinc finger MYM-type protein 3-like -1.8616556 3.6633963
RF55_9319 XP_016768793.1 -1.6023217 3.8961635
RF55_952 GB42014 E3 ubiquitin-protein ligase TRIP12-like -1.6637152 3.6314244
RF55_3561 GB41659 endothelin-converting enzyme 1 -1.9116224 3.3339080
RF55_4175 GB44311 actin related protein 1 -1.4407595 3.7728266
RF55_7804 -2.5441138 2.6300085
RF55_1689 XP_016768411.1 -3.3768014 1.7465719
RF55_5052 XP_016773337.1 -2.4182694 2.6840874
RF55_457 GB40931 uncharacterized protein LOC409781 -2.3507186 2.6953986
RF55_7632 XP_016767095.1 -2.0462508 2.9941556
RF55_11518 GB41804 nardilysin -2.2810020 2.7512083
RF55_4355 XP_016771542.1 -2.4450723 2.5183903
RF55_1518 XP_016768753.1 -3.0929627 1.8614463
RF55_5804 XP_016766957.1 -2.6227377 2.2732244
RF55_4425 GB51264 glutamine-dependent NAD(+) synthetase, transcript variant X3 -2.1938416 2.6792288
RF55_5947 XP_016768497.1 -2.0359071 2.6987690
RF55_3209 GB46684 monocarboxylate transporter 3-like -2.2501560 2.4459333
RF55_4132 XP_006572145.2 -1.8924997 2.7949094
RF55_3822 XP_016769466.1 -2.5889623 2.0767884
RF55_8207 XP_016767693.1 -2.6776356 1.9612772
RF55_3129 GB53974 probable RNA helicase armi -2.4754839 2.1042263
RF55_8822 GB41970 ras-like protein 2-like -2.5012521 2.0767873
RF55_9449 GB55840 protein sidekick-1-like -1.9739288 2.4747175
RF55_583 GB41366 protein MLP1-like -2.5149738 1.9248983
RF55_5597 GB46705 muscle M-line assembly protein unc-89 -4.2010432 0.1942554
RF55_7779 GB40928 tripartite motif-containing protein 2-like -1.9058556 2.4627030
RF55_1209 XP_016766933.1 -1.8405716 2.4685968
RF55_2958 XP_016771468.1 -2.2465795 1.9449655
RF55_7227 GB45211 troponin C type I -3.4951202 0.6960651
RF55_15397 XP_016766611.1 -2.1887540 1.9674339
RF55_3792 GB42024 translation initiation factor 2 -2.3474211 1.7699710
XLOC_009000 -1.9702840 2.1399072
RF55_1494 XP_016771667.1 -1.8255253 2.2245942
RF55_2964 GB45277 multidrug resistance-associated protein 4-like -1.9410464 2.0992859
RF55_13040 XP_016771370.1 -1.7071168 2.3051344
XLOC_009717 -1.8567534 2.1300834
RF55_6105 GB40496 aftiphilin-like -1.9290288 2.0409600
RF55_2225 XP_016769102.1 -2.4576563 1.5031576
RF55_7166 GB51290 ultrabithorax -1.8574204 2.0948477
RF55_2340 GB55485 DNA methyltransferase 3 -2.2221680 1.7086023
RF55_5141 GB51219 eye-specific diacylglycerol kinase -1.5771776 2.3341264
RF55_3424 GB42681 mucin-5AC-like -1.9129112 1.9909363
RF55_335 GB42666 serine palmitoyltransferase 2-like -2.1856978 1.6894768
RF55_2921 GB40416 twist -2.1419203 1.6755463
RF55_1441 GB47599 cytoplasmic dynein 1 light intermediate chain 1 -1.3649356 2.3461757
XLOC_001241 -1.9132811 1.7758352
RF55_404 GB53011 polyphosphoinositide phosphatase -2.1273247 1.5615310
RF55_11430 XP_016769030.1 -2.0923206 1.5691347
RF55_1609 GB40975 gamma-aminobutyric acid receptor subunit beta -1.9326037 1.6691322
RF55_5498 GB55971 palmitoyltransferase ZDHHC9-like -1.8138672 1.6963432
RF55_13282 GB54319 synaptotagmin 20 -1.8203872 1.6560353
RF55_4134 XP_016771187.1 -1.6338628 1.7842745
RF55_3869 GB51413 C3 and PZP-like alpha-2-macroglobulin domain-containing protein 8-like -1.8352815 1.5643281
RF55_5507 XP_016772718.1 -1.5504913 1.7564732
RF55_3824 XP_016768669.1 -1.5248764 1.6085396
XLOC_005436 -1.7586500 1.3642664
RF55_10519 GB54446 arginine kinase -2.9654802 0.1456319
RF55_310 100576851 ornithine decarboxylase antizyme 1-like -2.1712838 0.4835235
RF55_3137 GB54056 serine hydroxymethyltransferase, cytosolic -0.5039290 0.3060241
RF55_6300 XP_016767697.1 -0.1938198 0.3975841
RF55_4024 XP_016767817.1 -0.2959092 0.2953227

Overlap of specific pheromone-sensitive alternatively-spliced genes

lf.alt <- lf.alt.splice$Name[lf.alt.splice$Name != " "] # Exclude genes with no A. mellifera names
ln.alt <- ln.alt.splice$Name[ln.alt.splice$Name != " "]
venn(list(Apis = am.alt.splice$Name,`L. flavus` = lf.alt,`L. niger` = ln.alt))

Version Author Date
f260a62 Luke Holman 2019-03-07

Gene co-expression network analysis

First, we define a series of functions for gene co-expression network analysis.

# This function uses the ComBat function from the package 'sva' to remove variance in gene expression
# that is due to colony and species, allowing us to detect variance due to queen pheromone treatment.
# The use of ComBat in this fashion follows recommendations from the author of the WGCNA package. 
remove.effects.combat <- function(expression.data){
  sampleIDs <- rownames(expression.data)
  ids <- with(treatments[match(sampleIDs, treatments$id), ], 
              data.frame(
                id = sampleIDs,
                species = species,
                treatment = treatment,
                colony = paste(species, colony, sep = "")))
  
  modcombat <- model.matrix(~as.factor(treatment), data=ids)
  shh <- capture.output(expression.data <- ComBat(dat = t(expression.data), 
                                                  batch = ids$species, 
                                                  mod = modcombat, 
                                                  par.prior = TRUE))
  shh <- capture.output(expression.data <- t(ComBat(dat = expression.data, 
                                                    batch = ids$colony, 
                                                    mod = modcombat, 
                                                    par.prior = TRUE)))
  list(expression.data, ids)
}


# Build a gene coexpresison network using WGCNA package
build.network <- function(expression.data.list){
  # Pick the soft thresholding power that gives a model fit of R^2 > 0.8 for the scale-free topology model
  soft.power <- pickSoftThreshold(expression.data.list[[1]], 
                                  RsquaredCut = 0.8, verbose = 0, powerVector = 1:30)
  # Use this power to generate a gene co-expression network, using the default settings
  network <- blockwiseModules(expression.data.list[[1]], 
                              power = soft.power$powerEstimate,
                              networkType = "signed",
                              minModuleSize = 30,
                              verbose = 0,
                              saveTOMs = T)
  list(network, expression.data.list[[2]])
}


# By default, WGCNA gives the transcriptional modules random names like 'turqoise' or 'darkred'. 
# I think it's more helpful to define the biggest module as 'Module 1', the second biggest as 'Module 2', etc
# I use the label 'Module 0' for genes that were not assigned to a module
convert.module.colors.to.names <- function(network){
  module.sizes <- table(network[[1]]$colors) %>% sort %>% rev
  module.sizes <- c(module.sizes[names(module.sizes) == "grey"], 
                    module.sizes[names(module.sizes) != "grey"])
  module.mappings <- data.frame(color = names(module.sizes), 
                                new.name = paste("Module", 
                                                 0:(length(module.sizes)-1)), stringsAsFactors = F)
  network[[1]]$colors <- module.mappings$new.name[match(network[[1]]$colors, module.mappings$color)]
  names(network[[1]]$MEs) <- gsub("ME", "", names(network[[1]]$MEs))
  names(network[[1]]$MEs) <- module.mappings$new.name[match(names(network[[1]]$MEs), 
                                                            module.mappings$color)]
  network
}


# Rearrange the data in a handy format for stats and plotting, and remove the 'Module 0', the un-assigned genes
rearrange.eigengene.data <- function(network.list){
  cbind(network.list[[2]], network.list[[1]]$MEs) %>% 
    gather(Module, Eigengene, starts_with("Module")) %>% 
    filter(Module != "Module 0") %>%
    rename(Species = species, Treatment = treatment) %>% 
    arrange(Species, Treatment, colony, Module)
} 

Make the gene co-expression network, using the set of orthologous genes for all 4 species

# The 4 bad samples get removed, then we find the orthologous genes, the data are scaled with ComBat, and then we build the network using the lowest soft-thresholding power that gives at least R^2 > 0.8 model fit
OGGs <- make.OGGs(c("am", "bt", "ln", "lf"), bad.samples = bad.samples)
network <- OGGs[[1]] %>%
  remove.effects.combat() %>% 
  build.network() %>%
  convert.module.colors.to.names()
eigen.data <- network %>% rearrange.eigengene.data

Simple statistics about the network

Here is the number of orthologous genes that form the network:

length(network[[1]]$colors)
[1] 3465

Here is the number and size of modules in the network - module 0 refers to the unassigned genes.

table(network[[1]]$colors) %>% pander
Table continues below
Module 0 Module 1 Module 2 Module 3 Module 4 Module 5 Module 6
107 1639 543 346 288 160 154
Module 7 Module 8 Module 9
150 40 38

Make a plot of the module eigengenes

# Make a plot of the module eigengenes, split by species, module and treatment
treatments.network.plot <- function(dat){ 
  dat %>% mutate(Treatment = replace(as.character(Treatment), Treatment == "QP", "Queen\npheromone")) %>%
    ggplot(aes(Species, Eigengene, fill = Treatment)) + 
    geom_hline(yintercept = 0, linetype=2) + 
    geom_boxplot() + 
    facet_wrap(~Module) + 
    xlab(NULL) + 
    scale_x_discrete(labels = c("Apis\nmellifera", "Bombus\nterrestris", "Lasius\nflavus", "Lasius\nniger")) +
    scale_fill_brewer(name = " ", palette = "Set3", direction = -1) + 
    theme_bw() + 
    theme(strip.background = element_blank(), 
          axis.text.x = element_text(face = "italic"), 
          panel.border = element_rect(size=0.7), 
          legend.position = "top") 
}

eigen.data %>% treatments.network.plot()

Version Author Date
f260a62 Luke Holman 2019-03-07
ggsave(eigen.data %>% treatments.network.plot(), 
       file = "figures/Figure 3 - Module eigengenes.pdf", height = 6.6, width = 8)



Figure 3: The figure shows the distribution of module eigengenes for each combination of module, species, and queen pheromone (QP) treatment. Positive values mean that the focal group has higher eigengenes, which derived from the relative expression levels of a module of genes, than the average.

Run multivariate Bayesian model testing for treatment and species effects on eigengenes

Since the computation time is long, the model was defined and run in a separate R script, Script to run multivariate brms model.R. It is a multivariate model with 9 response variables: the eigengenes of the nine modules. We fit colony origin as a random effect in all models, accounting for similarity in gene expression between workers from the same colony. As shown in Table S14, we ran five models of this form, with different fixed effects (i.e. models with and without the predictors Species, Treatment, and their interaction). We then calculated the posterior model probabilities for these five models using bridge sampling (which is conceptually similar to pickoing the best-fitting model by AIC). These probabilities give the chance that each model is the best-fitting one in the set being considered, given the data and the priors. The table shows that a model containing the treatment effect, but not the species effect, is the best fitting (posterior probability > 0.99), and so we conclude that pheromone treatment affects gene expression, but we have no evidence for inter-species differences, or a treatment-by-species interaction.

Table S14: The posterior model probabilities of five competing multivariate Bayesian models of the module eigengene dataset. The best-fitting model (with posterior probability of almost 1) contains the treatment effect only (not the species effect, or the treatment-by-species interaction).

readRDS("data/brms_model_comparisons.rds") %>% pander()
  Posterior model probability
Treatment x Species 0
Treatment + Species 0
Treatment 1
Species 0
Intercept only 0

Table S15: Full summary of the best-fitting multivariate Bayesian model of the eigengene data for all nine modules, implemented in the programming language Stan via the R package brms. The most salient part of the output is the population-level effects (often called fixed effects), which give the coefficients for the intercept and the effect of queen pheromone treatment on the eigengenes for each module. The 9 response variables were all scaled to have mean 0 and variance 1 before running the model, meaning that the estimates can be interpreted as Cohen’s \(d\) effect size. The remaining sections describe the (co)variance associated with colony (which appears to be low), and the covariance in the residuals (which illustrates how eigengenes are correlated across modules).

cat(paste(readLines("data/brms_model.txt"), "\n", sep = ""))
 Family: MV(gaussian, gaussian, gaussian, gaussian, gaussian, gaussian, gaussian, gaussian, gaussian) 
   Links: mu = identity; sigma = identity
          mu = identity; sigma = identity
          mu = identity; sigma = identity
          mu = identity; sigma = identity
          mu = identity; sigma = identity
          mu = identity; sigma = identity
          mu = identity; sigma = identity
          mu = identity; sigma = identity
          mu = identity; sigma = identity 
 Formula: m1 ~ Treatment + (1 | p | colony) 
          m2 ~ Treatment + (1 | p | colony) 
          m3 ~ Treatment + (1 | p | colony) 
          m4 ~ Treatment + (1 | p | colony) 
          m5 ~ Treatment + (1 | p | colony) 
          m6 ~ Treatment + (1 | p | colony) 
          m7 ~ Treatment + (1 | p | colony) 
          m8 ~ Treatment + (1 | p | colony) 
          m9 ~ Treatment + (1 | p | colony) 
    Data: eigen.data %>% mutate(Module = gsub("Module ", "m" (Number of observations: 39) 
 Samples: 4 chains, each with iter = 5000; warmup = 2500; thin = 1;
          total post-warmup samples = 10000
 
 Group-Level Effects: 
 ~colony (Number of levels: 27) 
                                Estimate Est.Error l-95% CI u-95% CI Eff.Sample Rhat
 sd(m1_Intercept)                   0.08      0.06     0.00     0.21       4356 1.00
 sd(m2_Intercept)                   0.04      0.03     0.00     0.12       7092 1.00
 sd(m3_Intercept)                   0.04      0.03     0.00     0.13      10000 1.00
 sd(m4_Intercept)                   0.04      0.03     0.00     0.13       8519 1.00
 sd(m5_Intercept)                   0.05      0.03     0.00     0.12       4317 1.00
 sd(m6_Intercept)                   0.05      0.04     0.00     0.14       4690 1.00
 sd(m7_Intercept)                   0.06      0.04     0.00     0.17      10000 1.00
 sd(m8_Intercept)                   0.13      0.09     0.01     0.34       6666 1.00
 sd(m9_Intercept)                   0.04      0.03     0.00     0.12       5685 1.00
 cor(m1_Intercept,m2_Intercept)     0.02      0.32    -0.58     0.60      10000 1.00
 cor(m1_Intercept,m3_Intercept)     0.01      0.32    -0.60     0.61      10000 1.00
 cor(m2_Intercept,m3_Intercept)    -0.01      0.32    -0.62     0.60      10000 1.00
 cor(m1_Intercept,m4_Intercept)    -0.00      0.32    -0.62     0.61      10000 1.00
 cor(m2_Intercept,m4_Intercept)     0.05      0.32    -0.57     0.64      10000 1.00
 cor(m3_Intercept,m4_Intercept)    -0.02      0.32    -0.62     0.60      10000 1.00
 cor(m1_Intercept,m5_Intercept)     0.02      0.32    -0.58     0.61      10000 1.00
 cor(m2_Intercept,m5_Intercept)     0.00      0.32    -0.60     0.59      10000 1.00
 cor(m3_Intercept,m5_Intercept)    -0.02      0.32    -0.63     0.59      10000 1.00
 cor(m4_Intercept,m5_Intercept)     0.02      0.32    -0.58     0.62      10000 1.00
 cor(m1_Intercept,m6_Intercept)     0.00      0.31    -0.59     0.60      10000 1.00
 cor(m2_Intercept,m6_Intercept)    -0.02      0.32    -0.61     0.59      10000 1.00
 cor(m3_Intercept,m6_Intercept)     0.05      0.32    -0.58     0.64      10000 1.00
 cor(m4_Intercept,m6_Intercept)     0.03      0.31    -0.57     0.63      10000 1.00
 cor(m5_Intercept,m6_Intercept)     0.03      0.32    -0.58     0.63      10000 1.00
 cor(m1_Intercept,m7_Intercept)    -0.01      0.32    -0.61     0.59      10000 1.00
 cor(m2_Intercept,m7_Intercept)     0.02      0.32    -0.59     0.62      10000 1.00
 cor(m3_Intercept,m7_Intercept)     0.06      0.32    -0.57     0.65      10000 1.00
 cor(m4_Intercept,m7_Intercept)     0.02      0.32    -0.58     0.62      10000 1.00
 cor(m5_Intercept,m7_Intercept)    -0.01      0.32    -0.61     0.59      10000 1.00
 cor(m6_Intercept,m7_Intercept)    -0.02      0.32    -0.63     0.59      10000 1.00
 cor(m1_Intercept,m8_Intercept)     0.01      0.31    -0.59     0.61      10000 1.00
 cor(m2_Intercept,m8_Intercept)    -0.01      0.31    -0.60     0.58      10000 1.00
 cor(m3_Intercept,m8_Intercept)     0.04      0.32    -0.57     0.64      10000 1.00
 cor(m4_Intercept,m8_Intercept)     0.02      0.31    -0.58     0.61      10000 1.00
 cor(m5_Intercept,m8_Intercept)    -0.00      0.32    -0.60     0.60      10000 1.00
 cor(m6_Intercept,m8_Intercept)    -0.04      0.31    -0.62     0.57       7970 1.00
 cor(m7_Intercept,m8_Intercept)    -0.04      0.32    -0.62     0.58       6458 1.00
 cor(m1_Intercept,m9_Intercept)    -0.01      0.32    -0.62     0.60      10000 1.00
 cor(m2_Intercept,m9_Intercept)     0.05      0.33    -0.59     0.65      10000 1.00
 cor(m3_Intercept,m9_Intercept)    -0.00      0.32    -0.61     0.60      10000 1.00
 cor(m4_Intercept,m9_Intercept)    -0.05      0.32    -0.64     0.57      10000 1.00
 cor(m5_Intercept,m9_Intercept)     0.04      0.31    -0.57     0.62      10000 1.00
 cor(m6_Intercept,m9_Intercept)     0.02      0.31    -0.59     0.62       8255 1.00
 cor(m7_Intercept,m9_Intercept)     0.01      0.32    -0.60     0.61       6350 1.00
 cor(m8_Intercept,m9_Intercept)     0.03      0.32    -0.58     0.63       6231 1.00
 
 Population-Level Effects: 
                Estimate Est.Error l-95% CI u-95% CI Eff.Sample Rhat
 m1_Intercept      -0.27      0.18    -0.64     0.09       4403 1.00
 m2_Intercept      -0.23      0.19    -0.60     0.14       5015 1.00
 m3_Intercept       0.23      0.19    -0.16     0.60       5448 1.00
 m4_Intercept      -0.63      0.15    -0.92    -0.32       5864 1.00
 m5_Intercept      -0.18      0.18    -0.53     0.19       4295 1.00
 m6_Intercept       0.03      0.20    -0.36     0.43       5752 1.00
 m7_Intercept      -0.05      0.20    -0.46     0.34       5803 1.00
 m8_Intercept       0.13      0.21    -0.28     0.54       5686 1.00
 m9_Intercept       0.32      0.17    -0.01     0.67       4355 1.00
 m1_TreatmentQP     0.56      0.26     0.04     1.06       4299 1.00
 m2_TreatmentQP     0.48      0.27    -0.06     1.00       4542 1.00
 m3_TreatmentQP    -0.47      0.28    -1.01     0.10       5341 1.00
 m4_TreatmentQP     1.28      0.22     0.85     1.71       5443 1.00
 m5_TreatmentQP     0.37      0.26    -0.15     0.86       4059 1.00
 m6_TreatmentQP    -0.07      0.29    -0.65     0.50       5358 1.00
 m7_TreatmentQP     0.11      0.30    -0.47     0.69       5655 1.00
 m8_TreatmentQP    -0.27      0.29    -0.85     0.32       5407 1.00
 m9_TreatmentQP    -0.66      0.25    -1.16    -0.17       4120 1.00
 
 Family Specific Parameters: 
          Estimate Est.Error l-95% CI u-95% CI Eff.Sample Rhat
 sigma_m1     0.82      0.08     0.69     0.98      10000 1.00
 sigma_m2     0.84      0.08     0.70     1.01       7447 1.00
 sigma_m3     0.87      0.09     0.72     1.05       7227 1.00
 sigma_m4     0.70      0.07     0.58     0.85      10000 1.00
 sigma_m5     0.82      0.07     0.69     0.97       5832 1.00
 sigma_m6     0.90      0.09     0.75     1.10       6538 1.00
 sigma_m7     0.92      0.09     0.76     1.12      10000 1.00
 sigma_m8     0.91      0.10     0.75     1.12      10000 1.00
 sigma_m9     0.79      0.07     0.66     0.94       6247 1.00
 
 Residual Correlations: 
               Estimate Est.Error l-95% CI u-95% CI Eff.Sample Rhat
 rescor(m1,m2)     0.56      0.10     0.35     0.73       6438 1.00
 rescor(m1,m3)     0.69      0.08     0.51     0.82       7120 1.00
 rescor(m2,m3)     0.25      0.12    -0.00     0.48      10000 1.00
 rescor(m1,m4)     0.53      0.10     0.31     0.71       8099 1.00
 rescor(m2,m4)     0.73      0.07     0.56     0.84      10000 1.00
 rescor(m3,m4)     0.10      0.13    -0.17     0.35      10000 1.00
 rescor(m1,m5)     0.59      0.10     0.38     0.76       5667 1.00
 rescor(m2,m5)     0.66      0.08     0.48     0.79       5941 1.00
 rescor(m3,m5)     0.42      0.11     0.19     0.61       8145 1.00
 rescor(m4,m5)     0.71      0.07     0.55     0.83       7301 1.00
 rescor(m1,m6)     0.65      0.09     0.45     0.79       6974 1.00
 rescor(m2,m6)     0.19      0.13    -0.07     0.43      10000 1.00
 rescor(m3,m6)     0.64      0.08     0.46     0.78       8022 1.00
 rescor(m4,m6)     0.32      0.12     0.06     0.54       8027 1.00
 rescor(m5,m6)     0.78      0.06     0.65     0.87      10000 1.00
 rescor(m1,m7)     0.59      0.10     0.36     0.75      10000 1.00
 rescor(m2,m7)     0.59      0.09     0.39     0.74      10000 1.00
 rescor(m3,m7)     0.71      0.07     0.54     0.83      10000 1.00
 rescor(m4,m7)     0.32      0.12     0.06     0.55      10000 1.00
 rescor(m5,m7)     0.35      0.12     0.11     0.56       8081 1.00
 rescor(m6,m7)     0.21      0.13    -0.07     0.45       8440 1.00
 rescor(m1,m8)     0.53      0.11     0.29     0.71      10000 1.00
 rescor(m2,m8)     0.53      0.10     0.30     0.71      10000 1.00
 rescor(m3,m8)     0.55      0.10     0.34     0.72      10000 1.00
 rescor(m4,m8)     0.46      0.11     0.22     0.66      10000 1.00
 rescor(m5,m8)     0.49      0.11     0.26     0.68      10000 1.00
 rescor(m6,m8)     0.39      0.12     0.13     0.60      10000 1.00
 rescor(m7,m8)     0.44      0.12     0.18     0.65      10000 1.00
 rescor(m1,m9)     0.57      0.10     0.35     0.74       5328 1.00
 rescor(m2,m9)     0.77      0.06     0.64     0.87       7273 1.00
 rescor(m3,m9)     0.54      0.10     0.33     0.70      10000 1.00
 rescor(m4,m9)     0.45      0.11     0.21     0.65      10000 1.00
 rescor(m5,m9)     0.83      0.05     0.71     0.90      10000 1.00
 rescor(m6,m9)     0.60      0.09     0.39     0.75      10000 1.00
 rescor(m7,m9)     0.57      0.10     0.35     0.73      10000 1.00
 rescor(m8,m9)     0.52      0.11     0.28     0.70      10000 1.00
 
 Samples were drawn using sampling(NUTS). For each parameter, Eff.Sample 
 is a crude measure of effective sample size, and Rhat is the potential 
 scale reduction factor on split chains (at convergence, Rhat = 1).

Plot the correlations between all modules and the pheromone treatment

meta.module.plot <- function(network){
 
  MET <- network[[1]]$MEs 
  MET <- data.frame(QP = (network[[2]]$treatment %>% as.numeric())-1, MET) %>% dplyr::select(-Module.0)
  names(MET) <- gsub("[.]", " ", names(MET))
  cluster <- (1 - cor(MET)) %>% as.dist() %>% hclust()
  ordering <- cluster$labels[cluster$order]
  heat.map.data <- cor(MET) %>% melt %>% 
    mutate(Var1 = factor(Var1, levels = ordering),
           Var2 = factor(Var2, levels = ordering)) %>% 
    rename(Corr = value)
  heat.map <- heat.map.data %>% ggplot(aes(Var1, Var2, fill = Corr)) + geom_tile() + 
    scale_fill_gradient2(low = brewer.pal(9, "RdBu")[8], 
                         mid = "white", 
                         high = brewer.pal(9, "RdBu")[2]) + 
    xlab(NULL) + ylab(NULL) + 
    theme_bw() + 
    theme(panel.border = element_blank(), 
          panel.grid = element_blank()) + 
    scale_x_discrete(expand = c(0,0)) + 
    scale_y_discrete(expand = c(0,0))
 
  dendrogram <- ggdendrogram(cluster) + theme(axis.text.x = element_blank(), axis.text.y = element_blank())
  
  p1 <- grid.arrange(dendrogram, heat.map)
  invisible(p1)
}

meta.module.plot(network)

Version Author Date
f260a62 Luke Holman 2019-03-07



Dendrogram and heat map showing the correlations among module eigengene values and the queen pheromone treatment (QP; coded as zero and 1 for the control and treatment respectively). Modules with red colour, or which are close on the dendrogram, show more correlated expression. The queen pheromone treatment was correlated with Module 5, but was relatively uncorrelated with the other modules.

Table S16: Results of Spearman’s rank correlations testing for a relationship between the effect of queen pheromone on gene expression, and the connectedness of the gene. Negative values of Spearman’s Rho mean that highly pheromone-sensitive genes tend to have lower connectedness.

load("blockwiseTOM-block.1.RData") # Load the TOM from the network analysis - can be used to find connectedness for each ortholog

# Get the phermonone sensitivity value for each of the OGGs, and line it up with the connectedness data
suppressMessages(dd <- OGGs[[2]] %>% left_join(tbl(my_db, "ebseq_gene_am") %>% select(gene, PostFC) %>% rename(am=gene), copy=T) %>% rename(am_FC = PostFC) %>%
  left_join(tbl(my_db, "ebseq_gene_bt") %>% select(gene, PostFC) %>% 
              rename(bt=gene), copy=T) %>% rename(bt_FC = PostFC) %>%
  left_join(tbl(my_db, "ebseq_gene_lf") %>% select(gene, PostFC) %>% 
              rename(lf=gene), copy=T) %>% rename(lf_FC = PostFC) %>%
  left_join(tbl(my_db, "ebseq_gene_ln") %>% select(gene, PostFC) %>% 
              rename(ln=gene), copy=T) %>% rename(ln_FC = PostFC) %>%
  mutate(k = colSums(as.matrix(TOM))))

do.spearman <- function(dd, species, name){ # run spearman on each species
  test <- cor.test(dd$k, dd[, names(dd) == species] %>% log2 %>% abs, method = "spearman")  # Note that we convert the fold-change in expression with abs(log2(x)), to get pheromone sensitivity
  with(test, data.frame(Species = name, rho = estimate, p = p.value, row.names = NULL))
}

suppressWarnings(results <- rbind(do.spearman(dd, "am_FC", "Apis mellifera"),
                                  do.spearman(dd, "bt_FC", "Bombus terrestris"),
                                  do.spearman(dd, "lf_FC", "Lasius flavus"),
                                  do.spearman(dd, "ln_FC", "Lasius niger")))
rownames(results) <- NULL
saveRDS(results, file = "supplement/tab_S16.rds")
pander(results)
Species rho p
Apis mellifera -0.2463 4.834e-49
Bombus terrestris -0.2988 2.076e-72
Lasius flavus -0.4151 1.854e-144
Lasius niger -0.3159 4.677e-81

Characteristics of pheromone-sensitive genes in Apis

In this section, we search for correlates of the absolute Log_2 fold change in response to pheromone (where positive values denote genes whose expression differs strongly between the control and pheromone treatment). This section makes use of data kindly passed to us by Soojin Yi and Brendan Hunt.

  1. The data on queen and worker-specific gene expression come from Grozinger et al. 2007. We found that pheromone-sensitive genes tend to be over-expressed by queens relative to sterile workers. However, genes that are over-expressed by fertile workers relative to sterile workers did not tend to be more (or less) pheromone-sensitive.

  2. The methylation level (i.e. % methylated cytosines) data come from Galbraith et al. 2016 (provided by Soojin Yi). We found a negative correlation between methylation and pheromone-sensitivity, suggesting that pheromone-sensitive genes are hypomethylated.

  3. The CpG O/E values were calculated by Yi and colleagues for the latest A. mellifera genome annotation (as of late 2017). We found a positive correlation between CpG O/E and pheromone-sensitivity. High CpG is associated with lower rate of DNA methylation, again suggesting that pheromone-sensitive genes are hypomethylated.

  4. The columns on the H3K4me3, H3K27ac, and H3K36me3 histon modifications were calculated from the raw data from Wojciechowski et al. 2018, using the code in the separate R script wojciechowski_histone_analysis.R.

  5. The estimates of \(\gamma\), a measure of positive and negative selection similar to dN/dS, come from Harpur et al. 2014 PNAS. There was a significant positive correlation between \(\gamma\) and sensitivity to queen pheromone, suggesting that highly pheromone-sensitive genes tend to be positively selected.

  6. The codon adaptation index was provided by Brendan Hunt. A high codon adaptation index denotes high codon usage bias, meaning that certain synonymous codons are more common than others. Pheromone-sensitive genes showed low codon usage bias.

  7. Lastly, ‘expression level’ refers to the average expression of each gene, expressed as TPM (transcripts per million) as measured by the software RSEM in the present study. Highly expressed genes tended to be less pheromone-sensitive.

# import and clean up the data provided by Brendan Hunt
hunt.data <- read.delim("data/apis_gene_comparisons/Amel_AllData_012709.txt", 
                        header=T, stringsAsFactors = FALSE) %>% 
  mutate(log2RW.SW = log2(RW_bagel / SW_bagel))        # calculate log fold difference in gene expression between fertile and sterile workers
entrez.tbl <- read.delim("data/apis_gene_comparisons/am.gene_info.txt", stringsAsFactors = FALSE)[,c(2,5,6)] # import table of gene names (Entrez, old Beebase, and new Beebase)
names(entrez.tbl) <- c("entrez.id", "beebase1", "beebase2")
entrez.tbl <- entrez.tbl %>% mutate(beebase2 = gsub("BEEBASE:", "", beebase2))
entrez.tbl$beebase2[entrez.tbl$beebase2 == "-"] <- entrez.tbl$beebase1[entrez.tbl$beebase2 == "-"]
entrez.tbl$beebase2[grep("\\|", entrez.tbl$beebase2)] <- unname(unlist(sapply(entrez.tbl$beebase2[grep("\\|", entrez.tbl$beebase2)], function(x){
  namess <- strsplit(x, split = "\\|")[[1]]
  hits <-str_detect(namess, "GB")
  if(sum(hits) == 0) return(NA)
  return(namess[hits])
})))

hunt.data <- hunt.data %>% 
  dplyr::select(ID, log2Q.SW, log2RW.SW, CAI, cpgOE) %>% # get gene ID and the relevant data
  rename(beebase1 = ID) %>%                              # merge based on beebase IDs
  left_join(entrez.tbl, by = "beebase1") %>% 
  filter(!is.na(beebase2) & beebase2 != "-") %>% 
  rename(gene = beebase2) %>% 
  dplyr::select(gene, log2Q.SW, log2RW.SW, CAI, cpgOE)
hunt.data <- left_join(tbl(my_db, "ebseq_gene_am") %>%       # merge Hunt's data with our phermone sensitivity data
                         dplyr::select(gene, PostFC) %>% collect(), hunt.data, by = "gene") %>% 
  left_join(tbl(my_db, "bee_names") %>% collect, by = "gene")  # also add the gene names 

# Import methylation data provided by Soojin Yi and Xin Wu (teh data are from Galbraith et al PNAS)
methylation <- read.csv("data/apis_gene_comparisons/apis_gene_methyl_CG_OE.csv", stringsAsFactors = FALSE)
methylation <- tbl(my_db, "ebseq_gene_am") %>% collect %>% left_join(methylation, by = "gene") %>%
  filter(!is.na(Gene_body_methylation)) %>%
  left_join(tbl(my_db, "bee_names") %>% collect(), by = "gene") %>% distinct(gene, .keep_all = T)

# Import gamma data from Harpur et al 2014 PNAS
gamma_am <- tbl(my_db, "ebseq_gene_am") %>% collect() %>%
  left_join(read.table("data/apis_gene_comparisons/harpur_etal_gamma.txt", header=TRUE, stringsAsFactors=FALSE) %>% rename(gene = Gene), by = "gene") %>%
  filter(!is.na(gamma)) %>%
  dplyr::select(gene, PostFC, gamma) %>%
  mutate(PostFC = log2(PostFC)) %>% left_join(tbl(my_db, "bee_names"), copy=TRUE, by = "gene") %>%
  arrange(-abs(PostFC))


merged <- hunt.data %>% dplyr::select(gene, PostFC, log2Q.SW, log2RW.SW, CAI) %>% 
  left_join(methylation %>% dplyr::select(gene, CG_OE, Gene_body_methylation), by = "gene") %>% # merge in methylation data provided by Soojin Yi
  left_join(gamma_am %>% dplyr::select(gene, gamma), by = "gene") %>%                         # merge in gamma data from Harpur et al
  left_join(data.frame(gene = tbl(my_db, "rsem_am") %>% 
                         dplyr::select(gene) %>% collect(),  # calculate overall expression level from our own data
                       expression.level = (tbl(my_db, "rsem_am") %>% 
                                             dplyr::select(-gene) %>% 
                                             collect %>% rowSums())), by = "gene") %>% 
  left_join(dd %>% dplyr::select(am, k) %>% rename(gene=am), by = "gene") %>%
  mutate(CG_OE = -log2(CG_OE),                         # log2 CpG O/E ratio - change the sign, so that high values mean high methylation
         expression.level = log10(expression.level),   # log10 the expression level
         PostFC = abs(log2(PostFC))) %>%               # absolute log2 fold-change in response to pheromones (i.e. 'pheromone sensitivity' score)
  as.data.frame() #%>%
  # dplyr::select(-gene) 

# Add the data from Wojciechowski et al. 2018 Genome Biology
# There is gene-level data on the caste difference in 3 different histone modifications (from ChIP-seq),
# These data were created from Wojciechowski et al.'s raw data, as described in the separate R script wojciechowski_histone_analysis.R
merged <- merged %>% 
  left_join(tbl(my_db, "H3K4me3") %>% collect() %>% mutate(H3K4me3_caste = caste_difference) %>% select(gene, H3K4me3_caste), by = "gene") %>%
  left_join(tbl(my_db, "H3K27ac") %>% collect() %>% mutate(H3K27ac_caste = caste_difference) %>% select(gene, H3K27ac_caste), by = "gene") %>%
  left_join(tbl(my_db, "H3K36me3") %>% collect() %>% mutate(H3K36me3_caste = caste_difference) %>% select(gene, H3K36me3_caste), by = "gene") %>%
  dplyr::select(-gene) 
  

m.rename <- function(merged, col, new) {names(merged)[names(merged) == col] <- new; merged}
merged <- merged %>% m.rename("PostFC", "Pheromone sensitivity\n(absolute log fold)")   # re-label all the variables nicely
merged <- merged %>% m.rename("log2Q.SW", "Upregulation in adult queens\nover sterile workers (log fold)")
merged <- merged %>% m.rename("log2RW.SW", "Upregulation in fertile workers\nover sterile workers (log fold)")
merged <- merged %>% m.rename("CAI", "Codon usage bias\n(CAI)")
merged <- merged %>% m.rename("CG_OE", "DNA methylation frequency\n(CpG depletion)")
merged <- merged %>% m.rename("Gene_body_methylation", "DNA methylation frequency\n(BiS-seq)")
merged <- merged %>% m.rename("gamma", "Positive selection\n(Gamma)")
merged <- merged %>% m.rename("expression.level", "Log Expression level")
merged <- merged %>% m.rename("k", "Connectivity in the\ntranscriptome")
merged <- merged %>% m.rename("H3K4me3_caste", "Caste difference in\nH3K4me3 modification")
merged <- merged %>% m.rename("H3K27ac_caste", "Caste difference in\nH3K27ac modification")
merged <- merged %>% m.rename("H3K36me3_caste", "Caste difference in\nH3K36me3 modification")

entrez.tbl <- entrez.tbl %>% rename(gene = beebase2) %>% select(gene, entrez.id)

# function to reorder a correlation matrix using hierarchical clustering
reorder_cormat <- function(cormat){ 
  dd <- as.dist((1-cormat)/2)
  hc <- hclust(dd)
  cormat[hc$order, hc$order]}

cormat <- reorder_cormat(cor(merged, use = 'pairwise.complete.obs', method = "spearman"))
cormat[upper.tri(cormat)] <- NA
diag(cormat) <- NA

cor.matrix <-  (melt(cormat) %>% filter(!is.na(value)))[,1:2] %>% mutate(cor=0,p=0) 
for(i in 1:nrow(cor.matrix)) cor.matrix[i, 3:4] <- cor.test(merged[, names(merged) == cor.matrix$Var1[i]], merged[, names(merged) == cor.matrix$Var2[i]])[c(4,3)] %>% unlist
cor.matrix$p <- p.adjust(cor.matrix$p, method = "BH") # apply B-H p value correction
cor.matrix$sig <- ""
cor.matrix$sig[cor.matrix$p < 0.05] <- "*"   
cor.matrix$sig[cor.matrix$p < 0.001] <- "**"  
cor.matrix$sig[cor.matrix$p < 0.0001] <- "***"   
cor.matrix$label <- paste(format(round(cor.matrix$cor,2), nSmall =2), cor.matrix$sig, sep = "")
correlation.plot <- cor.matrix %>% 
  ggplot(aes(Var1, Var2, fill=cor)) + 
  geom_tile(colour = "grey10", size = 0.4, linetype = 3) + 
  scale_fill_distiller(palette = "RdYlBu") + 
  geom_text(aes(label = label), colour = "grey25", size = 3.5) + 
  xlab(NULL) + ylab(NULL) +
  scale_x_discrete(expand=c(0.01,0.01)) + scale_y_discrete(expand = c(0.01, 0.01)) + 
  theme_minimal() + theme(axis.text.x = element_text(angle = 45, hjust = 1, 
                                                     face = c("plain", "bold", rep("plain", 5), "bold",  rep("plain", 4))), 
                          axis.text.y = element_text(face = c("bold", "plain", "bold", rep("plain", 5), "bold",  "plain", "plain")), 
                          panel.grid = element_blank(), 
                          legend.position = "none") 
ggsave(correlation.plot, file = "figures/Figure 5 - correlations.pdf", width = 8, height = 8)
correlation.plot

Version Author Date
f260a62 Luke Holman 2019-03-07



Figure 5: Spearman correlations for various gene-level measurements from the present study and earlier research, for Apis mellifera (measurements from the present study are shown in bold). ‘Pheromone sensitivity’ was calculated as the absolute value of the Log\(_2\) fold difference in expression between pheromone treatment and the control. Expression level shows the logarithm of the average across our 6 Apis libraries. For the ‘Upregulation in queens/fertile workers’ data (Grozinger et al. 2007), positive values denote genes that have higher expression in queens or fertile workers, relative to sterile workers. For the three histone modification variables (Wojciechowski et al. 2018), high values indicate that the modification is more abundant in queen-destined larvae, and low values indicate it is more abundant in worker-destined larvae. The two DNA methylation variables give two different measures of the amount of gene body DNA methylation, namely an indirect measure (-log CpG O/E ratio) and a direct measure (BiS-seq, Galbraith et al. 2016). Codon usage bias was estimated using the codon adaptation index: high values indicate bias for particular synonymous codons. Lastly, the parameter gamma (\(\gamma\)) describes the form of selection, where positive values denote positive selection, and negative values purifying selection (data from Hunt et al. 2014).

Contrasting our Lasius data with results from Morandin et al. 2016

Morandin et al. 2016 (Genome Biology 17:43) studied whole transcriptomes from queens and workers in 16 diverse ant species, including two other species from the genus Lasius. Using BLAST, they grouped genes into OGGs (orthologous gene groups), and built a co-expression network using all the OGGs that were common to all 16 species via the software WGCNA (much like the present study). Their analysis yielded 36 modules, of which many showed significant queen-worker differences in their module eigengenes. Here, we want to test whether these queen- and worker-like modules significantly overlap with the pheromone-sensitive modules in the present study.

To do this, we used BLAST to identify orthologous gens in L. niger and L. flavus that belong to one of Morandin et al.’s OGGs. We then tested for significantly-greater-than-random overlap between Morandin et al’s modules, and our own study’s modules, using hypergeometric tests.

Of all the possible module pairs, we found 6 pairs that overlapped significantly more than expected (FDR-corrected). One of these pairs included our highly pheromone-sensitive module, Module 4, which overlapped with the caste-biased Module 13 from Morandin et al. The intersecting genes include protein take-out like, a NAD kinase 2, a serine protease, and histone H2A-like.

morandin.orthology <- read.csv("data/morandin_comparison_data/Morandin to Holman orthology.csv", stringsAsFactors = FALSE)
morandin.module.membership <- read.csv("data/morandin_comparison_data/Morandin module membership.csv", stringsAsFactors = FALSE)
morandin.module.caste.bias <- read.csv("data/morandin_comparison_data/Morandin module caste bias.csv", stringsAsFactors = FALSE)
# Create list of all the L. niger & L. flavus genes are are part of
# the Orthologous Gene Groups (OGGs) from Morandin et al.
# Here are the 3634 genes for which we have 1-to-1 orthologs in all 18 species:
morandin.oggs <- make.OGGs(c("ln", "lf"))[[2]] %>% 
  left_join(morandin.orthology, by = "ln") %>%
  filter(!is.na(morandin.ogg)) %>% 
  left_join(morandin.module.membership, by = "morandin.ogg") %>%
  left_join(tbl(my_db, "ln2am") %>% 
              left_join(tbl(my_db, "bee_names"), by = c("am" = "gene")) %>%
              filter(!is.na(name)) %>% select(ln, name, am) %>% 
              rename(apis.name = name) %>% collect(n=Inf), by = "ln") %>%
  left_join(morandin.module.caste.bias, by = "module") %>%
  rename(morandin.module = module) %>%
  left_join(data.frame(ln = OGGs[[2]]$ln, 
                       holman.module = network[[1]]$colors, 
                       stringsAsFactors = F), by = "ln") %>%
  left_join(tbl(my_db, "ebseq_gene_ln") %>% 
              select(gene, PostFC) %>% collect(n=Inf) %>% rename(ln = gene), by = "ln") %>%
  rename(FC.pheromone = PostFC)
overlaps <- table(morandin.oggs$morandin.module, 
                  morandin.oggs$holman.module) %>% 
  melt() %>% rename(morandin.module = Var1, 
                    holman.module = Var2, 
                    overlaps = value) %>%
  filter(holman.module != "Module 0") %>%
  left_join(table(morandin.oggs$morandin.module) %>% 
              melt() %>% rename(mor.mod.size = value), 
            by = c("morandin.module" = "Var1")) %>% 
  left_join(table(morandin.oggs$holman.module) %>% melt() %>% 
              rename(hol.mod.size = value), by = c("holman.module" = "Var1"))

# List all the Morandin et al. modules that significantly overlap with our own modules
overlaps <- data.frame(
  overlaps, 
  do.call("rbind", 
          lapply(1:nrow(overlaps), 
                 function(i) with(overlaps, 
                                  overlap.hypergeometric.test(
                                    overlaps[i], 
                                    mor.mod.size[i], 
                                    hol.mod.size[i], 
                                    nrow(morandin.oggs), 
                                    species = "xx"))))[,2:3]) %>% 
  filter(Test == "Overlap is higher than expected:") %>% 
  arrange(p) %>% select(-Test) %>% 
  left_join(morandin.oggs %>% 
              select(morandin.module, caste.bias) %>% 
              distinct(), by = "morandin.module") %>% 
  mutate(p = p.adjust(p, method = "BH"),
         morandin.module = paste("Module", morandin.module)) %>%
  filter(p < 0.05) 
names(overlaps) <- c("Morandin module", "Holman module", "n overlapping genes", "Size of Morandin module", "Size of Holman module", "p-value", "Caste bias of Morandin module")

Table S17: A list of the six module pairs, from Morandin et al. 2016 and the present study, which had significantly more genes in common than expected by chance. The p-values were calculated by running hypergeometric tests on all possible pairs of modules from the two studies, and then adjusting all the p-values using the Benjamini-Hochberg procedure.

saveRDS(overlaps, file = "supplement/tab_S17.rds")
overlaps %>% pander(split.cell = 40, split.table = Inf)
Morandin module Holman module n overlapping genes Size of Morandin module Size of Holman module p-value Caste bias of Morandin module
Module 32 Module 2 20 39 363 8.886e-09 Worker-biased
Module 31 Module 1 69 161 969 0.0002602 Queen-biased
Module 26 Module 8 5 49 24 0.0005457 Worker-biased
Module 32 Module 8 4 39 24 0.003328 Worker-biased
Module 13 Module 4 10 61 177 0.01554 Queen-biased
Module 10 Module 3 10 77 150 0.02318 Worker-biased

A list of the genes (OGGs) that appear in the present study’s Module 1 (which is pheromone-sensitive), and also in Morandin et al.’s Module 31 (which is caste-biased).

morandin.oggs %>% 
  filter(morandin.module == 31, holman.module == "Module 1") %>% 
  select(am, apis.name) %>% rename(`Apis ortholog ID` = am, `Apis ortholog name` = apis.name) %>% 
  kable.table()
Apis ortholog ID Apis ortholog name
GB54359 uncharacterized protein LOC726251 isoform X1
GB41231 ubiquitin-conjugating enzyme E2 G1
GB51699 WD repeat-containing protein 43-like
GB53328 DNA/RNA-binding protein KIN17
GB42693 la protein homolog
GB47191 uncharacterized protein LOC100576348 isoform X2
GB50004 protein preli-like isoform 1
GB50996 DNA-directed RNA polymerase II subunit RPB3-like
GB40765 ankyrin repeat domain-containing protein 12-like isoform X3
GB42664 probable ATP-dependent RNA helicase DDX43-like
GB42525 zinc finger protein ZPR1
GB53005 gem-associated protein 8-like
GB41769 actin-related protein 8 isoform 1
GB45492 protein misato-like isoform X1
GB54462 protein LLP homolog
GB46707 vacuolar protein-sorting-associated protein 25
GB51900 surfeit locus protein 6 homolog
GB49621 alpha-L-fucosidase
GB53359 alkylated DNA repair protein alkB homolog 1
GB40269 nucleolar protein 14 homolog isoform X1
GB40308 hsp70-binding protein 1-like
GB50555 thioredoxin peroxidase 3 isoform 2
GB49654 zinc finger protein 830-like
GB41153 peroxisomal membrane protein PEX16-like
GB53829 CD2 antigen cytoplasmic tail-binding protein 2 homolog
GB42223 elongation factor G, mitochondrial-like
GB46495 tetratricopeptide repeat protein 4
724533 small nuclear ribonucleoprotein Sm D3 isoform X1
GB53716 estrogen sulfotransferase-like
GB46074 survival motor neuron protein-like
GB40415 protein brambleberry-like
GB42058 helicase SKI2W
GB47633 serine/threonine-protein kinase D3 isoformX2
GB40949 homologous-pairing protein 2 homolog
GB44449 putative 28S ribosomal protein S5, mitochondrial isoform X1
GB45452 AP-3 complex subunit mu-1-like isoform X1
GB54526 mitotic spindle assembly checkpoint protein MAD1
GB42778 U6 snRNA-associated Sm-like protein LSm4-like
GB46398 thyrotroph embryonic factor isoformX1
GB43200 tRNA (uracil-5-)-methyltransferase homolog A-like isoform X2
GB43625 RNA methyltransferase-like protein 1-like
GB46881 COMM domain-containing protein 5-like isoform X2
GB54300 probable U2 small nuclear ribonucleoprotein A’ isoform X1
GB50740 ubiquitin-conjugating enzyme E2 S-like isoform X2
GB51106 mRNA turnover protein 4 homolog
GB40833 UPF0396 protein CG6066-like isoform X3
GB41176 polyglutamine-binding protein 1-like
GB10936 U4/U6 small nuclear ribonucleoprotein Prp3
GB50231 protein RMD5 homolog A-like
GB50167 probable 28S ribosomal protein S26, mitochondrial
102656337 mitotic spindle assembly checkpoint protein MAD2A-like isoform X1
GB53707 density-regulated protein-like isoform X1
GB46986 39S ribosomal protein L46, mitochondrial
GB53934 rho GTPase-activating protein 24-like
GB44172 protein CASC3-like isoform X2
GB46452 DNA replication factor Cdt1 isoform X1
GB53960 spliceosome-associated protein CWC15 homolog isoform 1
GB41603 PTB domain-containing adapter protein ced-6 isoform X2
GB50886 mediator of RNA polymerase II transcription subunit 30 isoform 1
GB47965 MKI67 FHA domain-interacting nucleolar phosphoprotein-like
GB46654 ribosomal L1 domain-containing protein CG13096-like
GB42204 rho guanine nucleotide exchange factor 3-like
GB54976 ER membrane protein complex subunit 8/9 homolog
GB50197 splicing factor 3A subunit 3 isoform X1
GB46606 peptidyl-prolyl cis-trans isomerase FKBP8-like isoform X3
GB40355 coiled-coil domain-containing protein 94-like isoform X2
GB49556 DNA replication licensing factor Mcm2-like isoform X1
GB51427 bromodomain-containing protein DDB_G0280777
GB52645 pinin

A list of the genes (OGGs) that appear in the present study’s Module 4 (which is pheromone-sensitive), and also in Morandin et al.’s Module 13 (which is caste-biased).

morandin.oggs %>% 
  filter(morandin.module == 13, holman.module == "Module 4") %>% 
  select(am, apis.name) %>% rename(`Apis ortholog ID` = am, `Apis ortholog name` = apis.name) %>% 
  pander(split.cell = 40, split.table = Inf)
Apis ortholog ID Apis ortholog name
GB54848 tumor suppressor candidate 3-like
GB53661 methyltransferase-like isoform X3
GB50524 uncharacterized protein LOC726417
GB54153 uncharacterized protein LOC100576236 isoform X1
GB54999 NAD kinase 2, mitochondrial-like
GB47507 histone H2A-like
GB42799 protein takeout-like
GB42899 uncharacterized protein LOC551133 isoform X2
GB43984 xenotropic and polytropic retrovirus receptor 1 homolog
GB43942 putative serine protease K12H4.7-like isoform X2

GO and KEGG enrichment for differentially expressed genes

First, define some functions we will need. See also the R script Script to set up for GO analyses.R, which was used to get the GO and KEGG data for Apis.

library(GO.db)
library(AnnotationHub)
select <- dplyr::select
rename <- dplyr::rename
filter <- dplyr::filter

if(!file.exists("data/component spreadsheets of queen_pheromone.db/all_apis_go_terms.rds")){
  library(AnnotationHub)
  # Connect to AnnotationHub, and get the annotations for A mellifera
  hub <- AnnotationHub::AnnotationHub()
 
  apis.db <- hub[["AH62534"]]
  apis_go_table <- dbconn(apis.db) %>% tbl("go") %>% collect() # Connect to GO table in the database
  
  apis_go <- tbl(dbconn(apis.db), "go") %>% left_join(tbl(dbconn(apis.db), "entrez_genes")) %>%
    select(ENTREZID, GO, ONTOLOGY) %>%
    rename(gene = ENTREZID, ontology = ONTOLOGY) %>% collect(n = Inf)
  
  apis_entrez_names <- tbl(dbconn(apis.db), "gene_info") %>% left_join(tbl(dbconn(apis.db), "entrez_genes")) %>%
    select(ENTREZID, GENENAME) %>%
    rename(entrez = ENTREZID, name = GENENAME) %>% collect(n = Inf)
  
  go_meanings <- dbconn(GO.db) %>% tbl("go_term") %>% select(go_id, term, ontology) %>% collect()
  
  saveRDS(apis.go, file = "data/component spreadsheets of queen_pheromone.db/all_apis_go_terms.rds")
  saveRDS(go_meanings, file = "data/component spreadsheets of queen_pheromone.db/go_meanings.rds")
  
  my_db$con %>% db_drop_table(table = "apis_go")
  copy_to(my_db, apis_go, "apis_go", temporary = FALSE)
  
  my_db$con %>% db_drop_table(table = "apis_entrez_names")
  copy_to(my_db, apis_entrez_names, "apis_entrez_names", temporary = FALSE)
  
  my_db$con %>% db_drop_table(table = "go_meanings")
  copy_to(my_db, go_meanings, "go_meanings", temporary = FALSE)
}

# Makes a database shortcut (lazy query) to a table of parent and child GO term relationships, from the massive GO.db database
make_db_shortcut <- function(tabl){
  dbconn(GO.db) %>% tbl("go_bp_offspring") %>%
    left_join(dbconn(GO.db) %>% tbl("go_term") %>% select(`_id`, go_id), by = "_id") %>% rename(parent_GO = go_id) %>%
    left_join(dbconn(GO.db) %>% tbl("go_term") %>% select(`_id`, go_id), by = c("_offspring_id" = "_id")) %>%
    rename(child_GO = go_id) %>% select(parent_GO, child_GO)
}

# Function to get all the descendants of a focal GO term, given its "hierarchy" (i.e. one of the lazy db queries BP, MF, or CC)
get_descendants <- function(ancestor, hierarchy) hierarchy %>% filter(parent_GO == ancestor) %>% select(child_GO) %>% collect() %>% .$child_GO

# Fucntion to run GSEA implemented in the fgsea package
GO.and.KEGG.gsea <- function(tabl = NULL, df = NULL, min.size = 5, keep.all = FALSE){
  
  p <- 0.05; if(keep.all) p <- 1 # Set the significance threshold
  
  if(!is.null(tabl)){
    # First, grab the data for the focal species. If not Apis, then get the names of the Apis orthologs via reciprocal best BLAST
    if(tabl == "ebseq_gene_am") {df <- tbl(my_db, tabl) %>% collect()}
    if(tabl == "ebseq_gene_bt") {
      df <- tbl(my_db, "ebseq_gene_bt") %>% collect() %>%
        left_join(make.OGGs(c("am", "bt"))[[2]], by = c("gene" = "bt")) %>%
        dplyr::select(-gene) %>% rename(gene = am) %>% filter(!is.na(gene))
    }
    if(tabl == "ebseq_gene_lf") {
      df <- tbl(my_db, "ebseq_gene_lf") %>% collect() %>%
        left_join(make.OGGs(c("am", "lf"))[[2]], by = c("gene" = "lf")) %>%
        select(-gene) %>% rename(gene = am) %>% filter(!is.na(gene))
    }
    if(tabl == "ebseq_gene_ln") {
      df <- tbl(my_db, "ebseq_gene_ln") %>% collect() %>%
        left_join(make.OGGs(c("am", "ln"))[[2]], by = c("gene" = "ln")) %>%
        select(-gene) %>% rename(gene = am) %>% filter(!is.na(gene))
    }
    # Calculate pheromone sensitivity for each gene
    df <- df %>% mutate(sensitivity = abs(log2(PostFC)) ) %>% arrange(-sensitivity) %>% as.data.frame() 
  }
  
  # Set up the geneList object in the form needed by the fgsea function - named, ranked vector of pheromone sensitivity per gene
  geneList <- df$sensitivity
  names(geneList) <- entrez.tbl$entrez.id[match(df$gene, entrez.tbl$gene)] # Convert Beebase2 to Entrez gene names
  gene_universe <- names(geneList)
  
  # Internal function to run GO enrichment
  GO.enrichment <- function(geneList, ontol){
    
    pathways <- tbl(my_db, "apis_go") %>% 
      filter(gene %in% gene_universe, 
             ontology == ontol) %>% 
      select(-ontology) %>% collect(n=Inf) 
    pathways <- with(pathways, split(gene, GO))
    result <- fgsea::fgsea(pathways, geneList, nperm = 10000, minSize = min.size, maxSize = 500) %>% 
      filter(pval <= p) 
    
    collapse_pathways <- fgsea::collapsePathways(result, pathways, geneList)
    pathways_to_keep <- c(collapse_pathways[[1]], names(collapse_pathways[[2]]))
    result <- result %>% filter(pathway %in% pathways_to_keep)
    
    result <- result %>% 
      rename(ID = pathway) %>% 
      left_join(tbl(my_db, "go_meanings") %>% 
                  select(-ontology) %>% collect(n=Inf), by = c("ID" = "go_id")) 
    
    if(nrow(result) == 0) return(NULL)
    if(ontol == "BP") Test_type <- "GO: Biological process"
    if(ontol == "MF") Test_type <- "GO: Molecular function"
    if(ontol == "CC") Test_type <- "GO: Cellular component"
    data.frame(Test_type = Test_type, result, stringsAsFactors = FALSE)
  }
  
  # Internal function to run KEGG enrichment
  kegg.enrichment <- function(geneList){
    apis_kegg <- clusterProfiler::download_KEGG("ame")
    apis_kegg_names <- apis_kegg[[2]]
    apis_kegg_focal <- apis_kegg[[1]] %>% filter(to %in% gene_universe)
    pathways <- with(apis_kegg_focal, split(to, from))
    result <- fgsea::fgsea(pathways, geneList, nperm = 10000, minSize = min.size, maxSize = 500) %>% 
      filter(pval <= p) 
    collapse_pathways <- fgsea::collapsePathways(result, pathways, geneList)
    
    result <- result %>% filter(pathway %in% c(collapse_pathways[[1]], names(collapse_pathways[[2]]))) %>% 
      rename(ID = pathway) %>% 
      left_join(apis_kegg_names %>% rename(term = to), by = c("ID" = "from")) %>%
      mutate(ID = str_replace_all(ID, "ame", "KEGG:"))
    
    if(nrow(result) == 0) return(NULL)
    data.frame(Test_type = "KEGG", result, stringsAsFactors = FALSE) 
  }
  
  rbind(GO.enrichment(geneList, "BP"),
        GO.enrichment(geneList, "MF"),
        GO.enrichment(geneList, "CC"),
        kegg.enrichment(geneList))  
}

# The previous function has a call to collapse_pathways(), which is great for finding over-arching patterns, but it results in a patchy version of Figure 2. This is because the pathways get collapsed slightly differently in each species, based on which genes happen to have detectable orthologs in A. mellifera, plus the gene expression data itself. This function attempts to fill all the holes in Figure 2 by running additional GSEA tests on all the GO terms that are missing from the figure. A small number of holes remain in Figure 2 due to missing orthologs in the non-Apis species, but mostly it does a good job.
test_child_pathways <- function(row, job_list, three_hierarchies, ebseq_tables, apis_go, go_meanings, three_OGGs, entrez.tbl){ # input: a dataframe of jobs, and the row of the job that needs doing
  
  # Get the focal GO_id, ontology, species, and GO tree
  go_id <- job_list$GO[row]
  ontol <- job_list$Test_type[row]
  Species <- job_list$Species[row]
  if(grepl("Biological", ontol)) {hierarchy <- three_hierarchies[[1]]; short_ontol <- "BP"}
  if(grepl("Molecular", ontol))  {hierarchy <- three_hierarchies[[2]]; short_ontol <- "MF"}
  if(grepl("Cellular", ontol))   {hierarchy <- three_hierarchies[[3]]; short_ontol <- "CC"}
  
  # Get the relevant data needed to rank the genes and make the 'geneList' object
  if(Species == "am") df <- ebseq_tables[[1]]
  if(Species == "bt") {
    df <- ebseq_tables[[2]] %>%
      left_join(three_OGGs[[1]], by = c("gene" = "bt")) %>%
      dplyr::select(-gene) %>% rename(gene = am) %>% filter(!is.na(gene))
  }
  if(Species == "lf") {
    df <- ebseq_tables[[3]] %>%
      left_join(three_OGGs[[2]], by = c("gene" = "lf")) %>%
      dplyr::select(-gene) %>% rename(gene = am) %>% filter(!is.na(gene))
  }
  if(Species == "ln") {
    df <- ebseq_tables[[4]] %>%
      left_join(three_OGGs[[3]], by = c("gene" = "ln")) %>%
      dplyr::select(-gene) %>% rename(gene = am) %>% filter(!is.na(gene))
  }
  
  # Set up the geneList object in the form needed by the fgsea function - named, ranked vector of pheromone sensitivity per gene
  df <- df %>% mutate(sensitivity = abs(log2(PostFC))) %>% arrange(-sensitivity) %>% as.data.frame() 
  geneList <- df$sensitivity
  names(geneList) <- entrez.tbl$entrez.id[match(df$gene, entrez.tbl$gene)] # Convert Beebase2 to Entrez gene names
  gene_universe <- names(geneList)
  
  # Run the GSEA, just on the focal GO term (and its descendants)
  pathways <- apis_go %>% filter(gene %in% gene_universe, 
                                 ontology == short_ontol) %>% select(-ontology) 
  
  pathways$GO[pathways$GO %in% get_descendants(go_id, hierarchy)] <- go_id
  pathways <- with(pathways, split(gene, GO))
  foc <- which(names(pathways) == go_id)
  result <- fgsea::fgsea(pathways[foc], geneList, nperm = 10000)
  
  if(nrow(result) > 0) {
    result <- rename(result, ID = pathway) %>% 
      left_join(go_meanings %>% select(-ontology), by = c("ID" = "go_id")) 
    
    return(data.frame(Test_type = ontol, result, Species, stringsAsFactors = FALSE))
  }
  else return(NULL)
}

# Function that attempts to fill in the gaps using test_child_pathways()
fill_in_GSEA_results <- function(GSEA_results){
  # Remove all KEGG and GO terms except those that are significant in at least one species
  results <- GSEA_results %>%
    filter(!is.nan(NES)) %>%
    filter(ID %in% (GSEA_results %>% filter(pval < 0.05) %>% .$ID %>% unique))
  
  # List GO terms that were not measured in all 4 species (often because of the GO concatenation step above)
  incomplete_GOs <- results %>% 
    filter(Test_type != "KEGG") %>% 
    group_by(Test_type, ID) %>% summarise(n = n()) %>% filter(!(n %in% c(4, 8, 12))) %>% .$ID
  
  job_list <- expand.grid(Species = c("am", "bt", "lf", "ln"),
                          GO = incomplete_GOs) %>%
    filter(!(paste(Species, GO) %in% paste(results$Species, results$GO))) %>%
    left_join(results %>% rename(GO = ID) %>% select(GO, Test_type) %>% distinct(), by = "GO")
  
  # Remove combinations that were already run from the job_list
  job_list <- job_list %>% filter(!(paste(Species, GO) %in% paste(GSEA_results$Species, GSEA_results$ID)))
  
  # Pull all of this information into memory, so that we can use mclapply for speed 
  # (mclapply does not play well with database connections)
  three_hierarchies <- list(
    make_db_shortcut("go_bp_offspring") %>% collect(),
    make_db_shortcut("go_mf_offspring") %>% collect(),
    make_db_shortcut("go_cc_offspring") %>% collect()
  )
  
  ebseq_tables <- list(
    tbl(my_db, "ebseq_gene_am") %>% collect(),
    tbl(my_db, "ebseq_gene_bt") %>% collect(),
    tbl(my_db, "ebseq_gene_lf") %>% collect(),
    tbl(my_db, "ebseq_gene_ln") %>% collect()
  )
  apis_go <- tbl(my_db, "apis_go") %>% collect()
  go_meanings <- tbl(my_db, "go_meanings") %>% collect()
  
  three_OGGs <- list(
    make.OGGs(c("am", "bt"))[[2]],
    make.OGGs(c("am", "lf"))[[2]],
    make.OGGs(c("am", "ln"))[[2]]
  )
  
  rbind(results, 
        lapply(1:nrow(job_list), function(i) 
          test_child_pathways(i, job_list, three_hierarchies, ebseq_tables, apis_go, go_meanings, three_OGGs, entrez.tbl)) %>% do.call("rbind", .)) %>%
    distinct() %>%
    rename(Description = term, pvalue = pval, p.adjust = padj) %>%
    filter(!is.nan(NES)) %>%
    mutate(p.adjust = p.adjust(pvalue, method = "BH")) %>%
    arrange(Test_type, Species, pvalue) %>% ungroup()
}


# Run the GO and KEGG enrichment analyses using GSEA implemented in fgsea 
# The functions here run GSEA on each species and all 4 ontologies, 
# then collapse redundant, smaller GO terms into higher-order ones, and then fill in any gaps to make Figure 2 less patchy
set.seed(1)
GO_and_KEGG_results_GSEA <- rbind(
  GO.and.KEGG.gsea("ebseq_gene_am", keep.all = TRUE) %>% mutate(Species = "am"),
  GO.and.KEGG.gsea("ebseq_gene_bt", keep.all = TRUE) %>% mutate(Species = "bt"), 
  GO.and.KEGG.gsea("ebseq_gene_lf", keep.all = TRUE) %>% mutate(Species = "lf"), 
  GO.and.KEGG.gsea("ebseq_gene_ln", keep.all = TRUE) %>% mutate(Species = "ln")) %>%
  fill_in_GSEA_results() 

GSEA for pheromone sensitivity of gene expression

Figure 2 provides a summary of the significant and/or interesting enriched GO terms, and is intended to provide a compact summary of the next 3 figures, which show every GO term for which we had data on at least 5 genes.

make_enrichment_heatmap <- function(GO_and_KEGG_results, pval_cutoff){
  plot_data <- GO_and_KEGG_results %>% 
    mutate(sig = " ",
           sig = replace(sig, pvalue < 0.05, "*"),
           sig = replace(sig, p.adjust < 0.05, "**")) 
  
  levels <- plot_data %>% 
    group_by(Test_type, Description) %>%
    summarise(summed_NES = sum(NES), n = n()) %>%
    arrange(desc(Test_type), summed_NES) %>% .$Description
  
  
  grid_arrange_shared_legend <- function(p1, p2) {
    plots <- list(p1, p2)
    g <- ggplotGrob(plots[[1]] + theme(legend.position="right"))$grobs
    legend <- g[[which(sapply(g, function(x) x$name) == "guide-box")]]
    lwidth <- sum(legend$width)
    arrangeGrob(
      arrangeGrob(p1 + theme(legend.position="none"), 
                  p2 + theme(legend.position="none"), ncol = 2, widths = c(0.56,0.44)),
      legend,
      ncol = 2,
      widths = unit.c(unit(1, "npc") - lwidth, lwidth))
  }

  output <- grid_arrange_shared_legend(
    plot_data %>% mutate(Description = factor(Description, levels)) %>%
      filter(Test_type %in% c("GO: Biological process", "GO: Molecular function")) %>%
      ggplot(aes(Species, Description, fill = NES)) +
      geom_tile(colour = "grey10", size = 0.4, linetype = 3) + 
      geom_text(aes(label = sig)) +
      scale_fill_distiller(palette = "RdYlBu") + 
      scale_y_discrete(labels = function(x) str_wrap(x, width = 55), expand = c(0,0)) +
      scale_x_discrete(expand = c(0,0)) +
      facet_grid(rows = vars(Test_type), scales = "free_y", space = "free_y") + 
      theme_minimal() +
      theme(panel.border = element_rect(size = 0.8, colour = "grey10", fill = NA),
            strip.text = element_text(size = 10)) + 
      guides(fill = guide_colourbar(frame.colour = "grey10", ticks.colour = "grey10")) + 
      ylab(NULL) + xlab(NULL), 
    plot_data %>% mutate(Description = factor(Description, levels)) %>%
      filter(Test_type %in% c("GO: Cellular component", "KEGG")) %>%
      ggplot(aes(Species, Description, fill = NES)) +
      geom_tile(colour = "grey10", size = 0.4, linetype = 3) + 
      geom_text(aes(label = sig)) +
      scale_fill_distiller(palette = "RdYlBu") + 
      scale_y_discrete(labels = function(x) str_wrap(x, width = 30), expand = c(0,0)) +
      scale_x_discrete(expand = c(0,0)) +
      facet_grid(rows = vars(Test_type), scales = "free_y", space = "free_y") + 
      theme_minimal() +
      theme(panel.border = element_rect(size = 0.8, colour = "grey10", fill = NA),
            strip.text = element_text(size = 10)) + 
      guides(fill = guide_colourbar(frame.colour = "grey10", ticks.colour = "grey10")) + 
      ylab(NULL) + xlab(NULL))  
  
  grobTree(rectGrob(gp = gpar(fill="white", lwd = 0)), output)
}

figure2 <- make_enrichment_heatmap(GO_and_KEGG_results_GSEA, pval_cutoff = 0.05)
ggsave(figure2, file = "figures/Figure 2 - GO and KEGG.pdf", height = 11.8, width = 9.5)
grid.draw(figure2)

Version Author Date
d5a6a73 lukeholman 2019-03-07
f260a62 Luke Holman 2019-03-07

Figure 2: A list of all the Gene Ontology (GO) and Kyoto Encyclopedia of Genes and Genomes (KEGG) terms that were significantly enriched or de-enriched among pheromone-sensitive genes in at least one of the four species. The colour shows the normalised expression score from gene set enrichment analysis; positive (red) values indicate that the ontology term is over-represented among genes whose expression is strongly affected by queen pheromone, and negative (blue) values indicate under-representation among these genes. Asterisks denote statistically significant enrichment (p < 0.05), and double asterisks mark results that remained significant after Benjamini-Hochberg correction. Empty squares denote cases where we did not find at least 5 genes annotated with the focal term.

Tabular results for GSEA for pheromone sensitivity in gene expression

Click the tabs to see tables for each of the four species.

Apis mellifera

Table S18: The results of GSEA (gene set enrichment analysis) for pheromone sensitivity in gene expression in Apis mellifera. The table lists GO and KEGG terms with their NES (normalized enrichment score), the associated raw and adjusted p-values (adjustment was performed using Benjamini-Hochberg correction), and the genes underlying the enrichment result.

add_name_col <- function(df){
  sapply(df$leadingEdge, function(x){
      data.frame(gene = x, stringsAsFactors = FALSE) %>%
        left_join(tbl(my_db, "apis_entrez_names") %>% collect(), by = c("gene" = "entrez")) %>% .$name %>%
        paste0(collapse = "; ")
    }) -> df$gene_names
  df %>% dplyr::rename(enriched_gene_ids = leadingEdge) %>% 
    mutate(enriched_gene_ids = map_chr(enriched_gene_ids, function(x) paste0(x, collapse = " ")))
}

tab_S18 <- GO_and_KEGG_results_GSEA %>% 
  filter(Species == "am" & pvalue < 0.05) %>%
  arrange(Test_type, pvalue) %>%
  select(-Species, -ES, -nMoreExtreme, -size) %>%
  add_name_col() 

saveRDS(tab_S18 %>% select(-enriched_gene_ids, -gene_names), file = "supplement/tab_S18.rds")
kable.table(tab_S18)
Test_type ID pvalue p.adjust NES enriched_gene_ids Description gene_names
GO: Biological process GO:0006368 0.0006892 0.0322997 -2.019849 551906 409928 412377 725696 552621 transcription elongation from RNA polymerase II promoter another transcription unit protein; RNA polymerase II elongation factor Ell; parafibromin; RNA polymerase-associated protein Rtf1; RNA polymerase II-associated factor 1 homolog
GO: Biological process GO:0015986 0.0064935 0.0773036 -1.737779 551766 409114 552682 409148 409236 551861 726120 727483 552699 ATP synthesis coupled proton transport ATP synthase subunit beta, mitochondrial; ATP synthase subunit alpha, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial Fo complex, subunit C2 (subunit 9); ATP synthase subunit O, mitochondrial; ATP synthase subunit e, mitochondrial; ATP synthase-coupling factor 6, mitochondrial; ATP synthase subunit epsilon, mitochondrial-like; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1
GO: Biological process GO:0016570 0.0165403 0.0984543 -1.652894 551906 412377 725696 552621 413130 histone modification another transcription unit protein; parafibromin; RNA polymerase-associated protein Rtf1; RNA polymerase II-associated factor 1 homolog; RNA polymerase-associated protein CTR9 homolog
GO: Biological process GO:0042742 0.0327906 0.1343292 1.461421 406143 406142 725074 406140 defense response to bacterium defensin 1; hymenoptaecin; omega-conotoxin-like protein 1; apidaecin 1
GO: Biological process GO:0016579 0.0447761 0.1393728 -1.457013 413813 411920 412114 409389 410109 408619 724338 410344 411572 410162 411362 552324 724537 552660 409403 408911 725744 412644 411981 protein deubiquitination ubiquitin carboxyl-terminal hydrolase isozyme L5; ubiquitin carboxyl-terminal hydrolase 22; ubiquitin carboxyl-terminal hydrolase 35-like; ubiquitin specific protease-like; ubiquitin carboxyl-terminal hydrolase 34; ubiquitin carboxyl-terminal hydrolase 3-like; OTU domain-containing protein 5-B; ubiquitin carboxyl-terminal hydrolase CYLD; ubiquitin carboxyl-terminal hydrolase 14; ataxin-3-like; ubiquitin carboxyl-terminal hydrolase 8-like; ubiquitin carboxyl-terminal hydrolase 5; ubiquitin carboxyl-terminal hydrolase 36; ubiquitin carboxyl-terminal hydrolase 46; ubiquitin carboxyl-terminal hydrolase 30 homolog; ubiquitin carboxyl-terminal hydrolase 47; ubiquitin thioesterase otubain-like; josephin-2; probable ubiquitin carboxyl-terminal hydrolase FAF-X
GO: Cellular component GO:0005576 0.0001000 0.0125000 1.535354 406121 100577331 406090 406133 406091 406088 410884 406143 406116 406095 503862 100049551 725725 724880 551268 406140 727193 410337 408365 410751 724246 412887 413705 406083 551407 725217 410928 411830 extracellular region major royal jelly protein 3; cell wall integrity and stress response component 1-like; major royal jelly protein 1; major royal jelly protein 4; major royal jelly protein 2; vitellogenin; phospholipase A1; defensin 1; major royal jelly protein 5; serine protease 34; corazonin; bursicon subunit alpha; peritrophin-1-like; allatostatin A; pancreatic triacylglycerol lipase-like; apidaecin 1; lipase member H-A-like; venom dipeptidylpeptidase IV; uncharacterized LOC408365; phospholipase A1 member A; growth/differentiation factor 2-like; A disintegrin and metalloproteinase with thrombospondin motifs 7-like; acidic mammalian chitinase-like; tachykinin; A disintegrin and metalloproteinase with thrombospondin motifs 14-like; uncharacterized protein PFB0145c-like; venom carboxylesterase-6; venom acid phosphatase
GO: Cellular component GO:0005667 0.0363014 0.1343292 -1.536247 409321 409887 410757 409301 412770 transcription factor complex mothers against decapentaplegic homolog 4; transcription factor Dp-1; circadian locomoter output cycles protein kaput; protein mothers against dpp; transcription factor E2F2
GO: Cellular component GO:0005743 0.0384615 0.1343292 -1.636964 406075 408968 413014 725881 727493 551169 726316 724264 550667 551811 726314 552482 724499 100577081 725566 408734 408548 725527 551337 413781 411790 411677 408837 412409 413186 mitochondrial inner membrane ADP/ATP translocase; cytochrome c-type heme lyase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 5; uncharacterized LOC725881; ubiquinone biosynthesis protein COQ4 homolog, mitochondrial-like; succinate dehydrogenase [ubiquinone] iron-sulfur subunit, mitochondrial-like; cytochrome b-c1 complex subunit 6, mitochondrial; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like; succinate dehydrogenase [ubiquinone] flavoprotein subunit, mitochondrial; graves disease carrier protein homolog; protein SCO2 homolog, mitochondrial; protoporphyrinogen oxidase; mitochondrial pyruvate carrier 2-like; dihydroorotate dehydrogenase (quinone), mitochondrial; succinate dehydrogenase [ubiquinone] cytochrome b small subunit, mitochondrial; succinate dehydrogenase [ubiquinone] flavoprotein subunit, mitochondrial-like; MICOS complex subunit Mic60; cytochrome b-c1 complex subunit Rieske, mitochondrial; flotillin-1; surfeit locus protein 1; solute carrier family 25 member 38-like; mitochondrial pyruvate carrier 1; cytochrome c oxidase subunit 5A, mitochondrial; mitochondrial import inner membrane translocase subunit TIM44; mitochondrial pyruvate carrier 3-like
GO: Cellular component GO:0005680 0.0444840 0.1393728 -1.464557 410290 726378 413293 409810 413499 724920 anaphase-promoting complex anaphase-promoting complex subunit 5; anaphase-promoting complex subunit 11-like; anaphase-promoting complex subunit 10; anaphase-promoting complex subunit 4; cell division cycle protein 23 homolog; anaphase-promoting complex subunit 15-like
GO: Cellular component GO:0005886 0.0488951 0.1438091 1.232225 100576816 100578083 725205 412740 100577755 100577334 100577482 725052 552546 100577062 411760 100576167 100577938 100578189 100576681 100578402 100577446 552785 100577590 plasma membrane odorant receptor 4-like; odorant receptor 14; odorant receptor 1; ligand-gated chloride channel homolog 3; odorant receptor 30a-like; odorant receptor 33; odorant receptor 25; odorant receptor 13a; protocadherin Fat 4; odorant receptor 4-like; metabotropic glutamate receptor 7; gustatory and pheromone receptor 32a-like; odorant receptor 18; odorant receptor 63; odorant receptor 57; odorant receptor 4; odorant receptor 27; ligand-gated ion channel pHCl; odorant receptor 20
GO: Molecular function GO:0008137 0.0011628 0.0322997 -2.129582 411411 725881 408909 724827 551660 725315 724264 NADH dehydrogenase (ubiquinone) activity NADH dehydrogenase [ubiquinone] iron-sulfur protein 3, mitochondrial; uncharacterized LOC725881; NADH-quinone oxidoreductase subunit B 2; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 7; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 8, mitochondrial; uncharacterized LOC725315; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like
GO: Molecular function GO:0005549 0.0021998 0.0419353 1.432831 677675 100576816 100578083 725205 677673 100577755 100577334 100577482 725052 551719 100577062 100577938 100578189 100576681 406109 100578402 100577446 406101 100577590 410068 odorant binding odorant binding protein 9; odorant receptor 4-like; odorant receptor 14; odorant receptor 1; odorant binding protein 14; odorant receptor 30a-like; odorant receptor 33; odorant receptor 25; odorant receptor 13a; odorant binding protein 16; odorant receptor 4-like; odorant receptor 18; odorant receptor 63; odorant receptor 57; odorant binding protein 6; odorant receptor 4; odorant receptor 27; odorant binding protein 4; odorant receptor 20; odorant binding protein 10
GO: Molecular function GO:0004984 0.0050010 0.0694583 1.460117 100576816 100578083 725205 100577755 100577334 100577482 725052 100577062 100577938 100578189 100576681 100578402 100577446 100577590 olfactory receptor activity odorant receptor 4-like; odorant receptor 14; odorant receptor 1; odorant receptor 30a-like; odorant receptor 33; odorant receptor 25; odorant receptor 13a; odorant receptor 4-like; odorant receptor 18; odorant receptor 63; odorant receptor 57; odorant receptor 4; odorant receptor 27; odorant receptor 20
GO: Molecular function GO:0004722 0.0104651 0.0872093 -1.667797 408701 409804 409430 551020 552412 552068 413080 protein serine/threonine phosphatase activity protein phosphatase 1H; serine/threonine-protein phosphatase PP1-beta catalytic subunit; serine/threonine-protein phosphatase alpha-2 isoform; probable protein phosphatase 2C T23F11.1; probable protein phosphatase CG10417; protein phosphatase 1L; pyruvate dehydrogenase [acetyl-transferring]-phosphatase 1, mitochondrial
GO: Molecular function GO:0005319 0.0124725 0.0922074 1.537033 406088 726182 408992 lipid transporter activity vitellogenin; larval-specific very high density lipoprotein; Niemann-Pick C1 protein-like
GO: Molecular function GO:0004252 0.0199040 0.1130908 1.364744 724565 724477 406095 409204 410894 409827 409143 413645 408534 724308 100576326 411358 724208 serine-type endopeptidase activity trypsin-7; vitamin K-dependent protein C; serine protease 34; trypsin; chymotrypsin-1; serine proteinase stubble; venom serine protease 34; trypsin alpha-3; trypsin; trypsin-1; trypsin-7; trypsin-1; venom protease-like
GO: Molecular function GO:0046933 0.0232558 0.1211240 -1.588367 551766 409114 552682 725661 409236 727483 552699 proton-transporting ATP synthase activity, rotational mechanism ATP synthase subunit beta, mitochondrial; ATP synthase subunit alpha, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; uncharacterized LOC725661; ATP synthase subunit O, mitochondrial; ATP synthase subunit epsilon, mitochondrial-like; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1
GO: Molecular function GO:0016614 0.0271038 0.1254808 1.440299 727367 552457 410746 410744 410748 551044 552395 oxidoreductase activity, acting on CH-OH group of donors glucose dehydrogenase [FAD, quinone]-like; glucose dehydrogenase [FAD, quinone]; glucose dehydrogenase [FAD, quinone]; glucose dehydrogenase [FAD, quinone]; glucose dehydrogenase [FAD, quinone]; glucose dehydrogenase [FAD, quinone]; glucose dehydrogenase [FAD, quinone]
KEGG KEGG:04711 0.0373726 0.1343292 -1.477501 410253 725614 408449 412108 410757 406112 408976 Circadian rhythm - fly ataxin-2 homolog; protein cycle; thyrotroph embryonic factor; casein kinase I-like; circadian locomoter output cycles protein kaput; period circadian protein; protein kinase shaggy

Bombus terrestris

Table S19: The results of GSEA (gene set enrichment analysis) for pheromone sensitivity in gene expression in Bombus terrestris. The table lists GO and KEGG terms with their NES (normalized enrichment score), the associated raw and adjusted p-values (adjustment was performed using Benjamini-Hochberg correction), and the genes underlying the enrichment result.

tab_S19 <- GO_and_KEGG_results_GSEA %>% 
  filter(Species == "bt" & pvalue < 0.05) %>%
  arrange(Test_type, pvalue) %>%
  select(-Species, -ES, -nMoreExtreme, -size) %>%
  add_name_col() 

saveRDS(tab_S19 %>% select(-enriched_gene_ids, -gene_names), file = "supplement/tab_S19.rds")
kable.table(tab_S19)
Test_type ID pvalue p.adjust NES enriched_gene_ids Description gene_names
GO: Biological process GO:0006030 0.0007056 0.0322997 1.683935 551323 724464 413481 413679 725932 408365 100577576 724382 100576184 727129 411273 413560 100577513 chitin metabolic process uncharacterized LOC551323; cuticular protein; probable chitinase 3; cuticular protein analogous to peritrophins 3-E; cuticular protein analogous to peritrophins 3-C; uncharacterized LOC408365; chondroitin proteoglycan-2-like; cuticular protein analogous to peritrophins 3-A; uncharacterized LOC100576184; uncharacterized LOC727129; uncharacterized protein DDB_G0287625-like; uncharacterized LOC413560; uncharacterized LOC100577513
GO: Biological process GO:0045087 0.0121690 0.0922074 1.588706 406143 406140 100576745 innate immune response defensin 1; apidaecin 1; leucine-rich repeat-containing protein 26-like
GO: Biological process GO:0000398 0.0364964 0.1343292 -1.381094 725352 413842 551620 725401 551974 552155 409347 413548 725142 411122 725947 413523 408606 413963 552529 408632 mRNA splicing, via spliceosome U6 snRNA-associated Sm-like protein LSm7; splicing factor U2af 38 kDa subunit; pre-mRNA-processing-splicing factor 8; U6 snRNA-associated Sm-like protein LSm3; thioredoxin-like protein 4A; U6 snRNA-associated Sm-like protein LSm8; U4/U6.U5 tri-snRNP-associated protein 1; intron-binding protein aquarius; U6 snRNA-associated Sm-like protein LSm2; splicing factor 1; U6 snRNA-associated Sm-like protein LSm6; pre-mRNA-processing factor 17; PRP3 pre-mRNA processing factor 3 homolog; splicing factor 3A subunit 3; U6 snRNA-associated Sm-like protein LSm4; spliceosome-associated protein CWC15 homolog
GO: Biological process GO:0015991 0.0417827 0.1365156 -1.376223 409148 406076 552410 409074 409946 552720 551093 409055 551721 725661 552476 ATP hydrolysis coupled proton transport ATP synthase, H+ transporting, mitochondrial Fo complex, subunit C2 (subunit 9); vacuolar H+ ATP synthase 16 kDa proteolipid subunit; V-type proton ATPase subunit e 2-like; V-type proton ATPase 21 kDa proteolipid subunit-like; V-type proton ATPase subunit d; V-type proton ATPase subunit E; V-type proton ATPase catalytic subunit A; V-type proton ATPase subunit H; V-type proton ATPase subunit B; uncharacterized LOC725661; V-type proton ATPase subunit F
GO: Biological process GO:0042742 0.0439150 0.1393728 1.475540 406143 406140 100576745 725074 defense response to bacterium defensin 1; apidaecin 1; leucine-rich repeat-containing protein 26-like; omega-conotoxin-like protein 1
GO: Cellular component GO:0005576 0.0001000 0.0125000 1.650311 410751 406143 551323 724464 413481 413679 406140 725932 408365 100577576 503862 724382 100576184 100126690 727129 410337 409307 100576512 410884 410451 411273 413560 724563 100577513 extracellular region phospholipase A1 member A; defensin 1; uncharacterized LOC551323; cuticular protein; probable chitinase 3; cuticular protein analogous to peritrophins 3-E; apidaecin 1; cuticular protein analogous to peritrophins 3-C; uncharacterized LOC408365; chondroitin proteoglycan-2-like; corazonin; cuticular protein analogous to peritrophins 3-A; uncharacterized LOC100576184; pheromone biosynthesis-activating neuropeptide; uncharacterized LOC727129; venom dipeptidylpeptidase IV; uncharacterized LOC409307; U8-agatoxin-Ao1a-like; phospholipase A1; venom serine carboxypeptidase; uncharacterized protein DDB_G0287625-like; uncharacterized LOC413560; uncharacterized LOC724563; uncharacterized LOC100577513
GO: Cellular component GO:0005886 0.0027027 0.0450450 1.544910 100578210 100577938 100577446 100577755 725297 100578083 100577334 411760 100578230 725205 551782 plasma membrane odorant receptor 5; odorant receptor 18; odorant receptor 27; odorant receptor 30a-like; gustatory receptor 10; odorant receptor 14; odorant receptor 33; metabotropic glutamate receptor 7; odorant receptor 115; odorant receptor 1; bestrophin-4-like
GO: Cellular component GO:0005694 0.0260593 0.1252852 1.511039 726963 412750 chromosome meiotic recombination protein SPO11; DNA topoisomerase 1
GO: Molecular function GO:0042302 0.0003016 0.0251357 1.737132 413115 725509 727392 726995 726451 726950 727197 724777 725300 724556 100577562 724649 724624 structural constituent of cuticle cuticular protein 19; cuticular protein 27; endocuticle structural glycoprotein SgAbd-2; endocuticle structural glycoprotein ABD-4; cuticle protein 7; pupal cuticle protein 20; cuticular protein 2; cuticular protein 14; cuticular protein 13; cuticular protein 17; probable LIM domain-containing serine/threonine-protein kinase DDB_G0286997; cuticular protein 21; endocuticle structural glycoprotein SgAbd-1
GO: Molecular function GO:0004984 0.0009223 0.0322997 1.703267 100578210 100577938 100577446 100577755 100578083 100577334 100578230 725205 olfactory receptor activity odorant receptor 5; odorant receptor 18; odorant receptor 27; odorant receptor 30a-like; odorant receptor 14; odorant receptor 33; odorant receptor 115; odorant receptor 1
GO: Molecular function GO:0005549 0.0011033 0.0322997 1.677641 100578210 100577938 100577446 100577755 100578083 100577334 100578230 677674 725205 406103 406109 odorant binding odorant receptor 5; odorant receptor 18; odorant receptor 27; odorant receptor 30a-like; odorant receptor 14; odorant receptor 33; odorant receptor 115; odorant binding protein 13; odorant receptor 1; odorant binding protein 2; odorant binding protein 6
GO: Molecular function GO:0008061 0.0011076 0.0322997 1.678200 551323 724464 413481 413679 725932 408365 100577576 724382 100576184 727129 411273 413560 100577513 chitin binding uncharacterized LOC551323; cuticular protein; probable chitinase 3; cuticular protein analogous to peritrophins 3-E; cuticular protein analogous to peritrophins 3-C; uncharacterized LOC408365; chondroitin proteoglycan-2-like; cuticular protein analogous to peritrophins 3-A; uncharacterized LOC100576184; uncharacterized LOC727129; uncharacterized protein DDB_G0287625-like; uncharacterized LOC413560; uncharacterized LOC100577513
GO: Molecular function GO:0102336 0.0097652 0.0863622 1.605581 100578829 552205 725031 725255 3-oxo-arachidoyl-CoA synthase activity elongation of very long chain fatty acids protein 1-like; elongation of very long chain fatty acids protein AAEL008004; elongation of very long chain fatty acids protein 6; elongation of very long chain fatty acids protein 7
GO: Molecular function GO:0102337 0.0097652 0.0863622 1.605581 100578829 552205 725031 725255 3-oxo-cerotoyl-CoA synthase activity elongation of very long chain fatty acids protein 1-like; elongation of very long chain fatty acids protein AAEL008004; elongation of very long chain fatty acids protein 6; elongation of very long chain fatty acids protein 7
GO: Molecular function GO:0102338 0.0097652 0.0863622 1.605581 100578829 552205 725031 725255 3-oxo-lignoceronyl-CoA synthase activity elongation of very long chain fatty acids protein 1-like; elongation of very long chain fatty acids protein AAEL008004; elongation of very long chain fatty acids protein 6; elongation of very long chain fatty acids protein 7
GO: Molecular function GO:0102756 0.0097652 0.0863622 1.605581 100578829 552205 725031 725255 very-long-chain 3-ketoacyl-CoA synthase activity elongation of very long chain fatty acids protein 1-like; elongation of very long chain fatty acids protein AAEL008004; elongation of very long chain fatty acids protein 6; elongation of very long chain fatty acids protein 7
GO: Molecular function GO:0016614 0.0231687 0.1211240 1.527243 552457 413098 552425 410745 oxidoreductase activity, acting on CH-OH group of donors glucose dehydrogenase [FAD, quinone]; glucose dehydrogenase [FAD, quinone]; glucose dehydrogenase [FAD, quinone]; glucose dehydrogenase [FAD, quinone]
GO: Molecular function GO:0043565 0.0305000 0.1343292 1.305352 726162 724196 725495 726370 725220 725302 413391 724373 100576194 410643 724456 552099 724301 100576220 413060 413558 406077 724412 724238 408443 724796 724422 724297 725502 100576147 410657 sequence-specific DNA binding homeobox protein goosecoid; retinal homeobox protein Rx1; homeobox protein GBX-2; uncharacterized LOC726370; homeobox protein Nkx-6.1-like; H2.0-like homeobox protein; homeobox protein MSX-2; homeobox protein Nkx-2.5-like; forkhead box protein J1-B-like; homeobox protein abdominal-A homolog; homeobox protein Msx; homeotic protein empty spiracles; paired mesoderm homeobox protein 2-like; homeobox protein rough-like; DNA-binding protein D-ETS-4; photoreceptor-specific nuclear receptor; homeotic protein antennapedia; muscle segmentation homeobox; paired box protein Pax-6-like; uncharacterized LOC408443; homeobox protein SIX6; homeobox protein Hox-B1a; uncharacterized LOC724297; homeobox protein ARX-like; fork head domain-containing protein FD4; inhibitory POU protein
GO: Molecular function GO:0004252 0.0451943 0.1393728 1.394571 726126 410438 724145 413645 724917 410894 724308 411358 409143 726718 serine-type endopeptidase activity proclotting enzyme; neuroendocrine convertase 1-like; transmembrane protease serine 9; trypsin alpha-3; uncharacterized LOC724917; chymotrypsin-1; trypsin-1; trypsin-1; venom serine protease 34; rhomboid-related protein 4-like
GO: Molecular function GO:0004888 0.0468442 0.1396648 1.460218 410478 406148 100576745 726214 406153 transmembrane signaling receptor activity nicotinic acetylcholine receptor beta1 subunit; nicotinic acetylcholine receptor alpha7 subunit; leucine-rich repeat-containing protein 26-like; nicotinic acetylcholine receptor alpha1 subunit; nicotinic acetylcholine receptor alpha2 subunit
KEGG KEGG:00900 0.0029130 0.0455160 1.666599 413763 551189 725363 725817 Terpenoid backbone biosynthesis hydroxymethylglutaryl-CoA synthase 1; farnesyl pyrophosphate synthase-like; isopentenyl-diphosphate Delta-isomerase 1; diphosphomevalonate decarboxylase
KEGG KEGG:00910 0.0149136 0.0980780 1.563268 100577841 726898 727237 Nitrogen metabolism carbonic anhydrase 7-like; carbonic anhydrase 3; carbonic anhydrase 2-like
KEGG KEGG:03022 0.0204082 0.1133787 -1.375002 411786 412010 409906 550692 412268 410753 550665 551734 410305 410004 409735 411231 411144 411742 412919 410459 552563 551470 550895 724502 Basal transcription factors general transcription factor IIE subunit 1; general transcription factor IIH subunit 4; transcription initiation factor TFIID subunit 2; TATA-box-binding protein; transcription initiation factor IIA subunit 1; TATA-box-binding protein-like; transcription initiation factor IIA subunit 2; DNA excision repair protein haywire; transcription initiation factor TFIID subunit 12; transcription initiation factor TFIID subunit 10-like; transcription initiation factor TFIID subunit 6; general transcription factor IIH subunit 3; transcription initiation factor TFIID subunit 11; transcription initiation factor TFIID subunit 8-like; TATA box-binding protein-like protein 1; cyclin-H; transcription initiation factor TFIID subunit 7; general transcription factor IIF subunit 2; general transcription factor IIH subunit 1; transcription initiation factor TFIID subunit 5
KEGG KEGG:00360 0.0333296 0.1343292 1.499087 410639 725400 408622 410638 Phenylalanine metabolism alpha-methyldopa hypersensitive protein-like; 4-hydroxyphenylpyruvate dioxygenase; protein henna; aromatic-L-amino-acid decarboxylase

Lasius flavus

Table S20: The results of GSEA (gene set enrichment analysis) for pheromone sensitivity in gene expression in Lasius flavus. The table lists GO and KEGG terms with their NES (normalized enrichment score), the associated raw and adjusted p-values (adjustment was performed using Benjamini-Hochberg correction), and the genes underlying the enrichment result.

tab_S20 <- GO_and_KEGG_results_GSEA %>% 
  filter(Species == "lf" & pvalue < 0.05) %>%
  arrange(Test_type, pvalue) %>%
  select(-Species, -ES, -nMoreExtreme, -size) %>%
  add_name_col() 

saveRDS(tab_S20 %>% select(-enriched_gene_ids, -gene_names), file = "supplement/tab_S20.rds")
kable.table(tab_S20)
Test_type ID pvalue p.adjust NES enriched_gene_ids Description gene_names
GO: Biological process GO:0006464 0.0079458 0.0827686 1.603380 551967 410872 cellular protein modification process probable tubulin polyglutamylase TTLL2; SUMO-activating enzyme subunit 1
GO: Biological process GO:0006364 0.0144071 0.0976497 1.597910 725143 411026 411233 rRNA processing probable U3 small nucleolar RNA-associated protein 11; WD repeat-containing protein 36; U3 small nucleolar ribonucleoprotein protein MPP10
GO: Biological process GO:0042742 0.0153002 0.0980780 1.552196 406142 406143 defense response to bacterium hymenoptaecin; defensin 1
GO: Biological process GO:0006633 0.0161826 0.0984543 1.582131 724552 100578829 725031 552205 412166 100577192 413789 fatty acid biosynthetic process elongation of very long chain fatty acids protein AAEL008004-like; elongation of very long chain fatty acids protein 1-like; elongation of very long chain fatty acids protein 6; elongation of very long chain fatty acids protein AAEL008004; acyl-CoA Delta(11) desaturase; very-long-chain (3R)-3-hydroxyacyl-CoA dehydratase 2; elongation of very long chain fatty acids protein AAEL008004-like
GO: Biological process GO:0007020 0.0252395 0.1237232 1.512303 726073 411508 microtubule nucleation gamma-tubulin complex component 3; tubulin gamma-2 chain
GO: Cellular component GO:0005730 0.0023484 0.0419353 1.785677 725143 413404 724432 724129 nucleolus probable U3 small nucleolar RNA-associated protein 11; ribosome biogenesis protein WDR12 homolog; ribosomal RNA processing protein 36 homolog; pescadillo homolog
GO: Cellular component GO:0035267 0.0069751 0.0792628 1.630456 726816 408575 NuA4 histone acetyltransferase complex ruvB-like 2; DNA methyltransferase 1-associated protein 1
GO: Cellular component GO:0032040 0.0144522 0.0976497 1.577040 725143 411026 413649 small-subunit processome probable U3 small nucleolar RNA-associated protein 11; WD repeat-containing protein 36; rRNA-processing protein FCF1 homolog
GO: Cellular component GO:0005886 0.0220967 0.1200905 1.505998 725384 412740 725205 551848 411611 552785 551782 552546 plasma membrane odorant receptor 2; ligand-gated chloride channel homolog 3; odorant receptor 1; protocadherin-like wing polarity protein stan; tachykinin-like peptides receptor 99D; ligand-gated ion channel pHCl; bestrophin-4-like; protocadherin Fat 4
GO: Cellular component GO:0005856 0.0244862 0.1237232 1.514313 406154 412827 cytoskeleton profilin; Bardet-Biedl syndrome 2 protein homolog
GO: Cellular component GO:0031011 0.0356894 0.1343292 1.478919 726816 100576104 Ino80 complex ruvB-like 2; INO80 complex subunit B
GO: Molecular function GO:0004984 0.0127138 0.0922074 1.440536 725384 725205 olfactory receptor activity odorant receptor 2; odorant receptor 1
GO: Molecular function GO:0003779 0.0162086 0.0984543 1.542631 406154 411744 actin binding profilin; spectrin beta chain
GO: Molecular function GO:0005549 0.0176439 0.1025808 1.562299 725384 406109 406100 725205 406102 odorant binding odorant receptor 2; odorant binding protein 6; odorant binding protein 5; odorant receptor 1; odorant binding protein 1
GO: Molecular function GO:0042302 0.0290093 0.1318605 1.516549 100577562 100577189 409345 724556 727578 724624 structural constituent of cuticle probable LIM domain-containing serine/threonine-protein kinase DDB_G0286997; cuticular protein 6; cuticular protein 3; cuticular protein 17; uncharacterized LOC727578; endocuticle structural glycoprotein SgAbd-1
GO: Molecular function GO:0036459 0.0315236 0.1343292 -1.577174 411920 412114 409389 552660 410109 411572 411981 411362 408619 thiol-dependent ubiquitinyl hydrolase activity ubiquitin carboxyl-terminal hydrolase 22; ubiquitin carboxyl-terminal hydrolase 35-like; ubiquitin specific protease-like; ubiquitin carboxyl-terminal hydrolase 46; ubiquitin carboxyl-terminal hydrolase 34; ubiquitin carboxyl-terminal hydrolase 14; probable ubiquitin carboxyl-terminal hydrolase FAF-X; ubiquitin carboxyl-terminal hydrolase 8-like; ubiquitin carboxyl-terminal hydrolase 3-like
GO: Molecular function GO:0005319 0.0344271 0.1343292 1.495474 406088 410793 551250 411955 408696 726783 lipid transporter activity vitellogenin; uncharacterized LOC410793; microsomal triglyceride transfer protein large subunit; uncharacterized LOC411955; uncharacterized LOC408696; vitellogenin-like
GO: Molecular function GO:0102336 0.0396585 0.1343292 1.478584 724552 100578829 725031 552205 413789 3-oxo-arachidoyl-CoA synthase activity elongation of very long chain fatty acids protein AAEL008004-like; elongation of very long chain fatty acids protein 1-like; elongation of very long chain fatty acids protein 6; elongation of very long chain fatty acids protein AAEL008004; elongation of very long chain fatty acids protein AAEL008004-like
GO: Molecular function GO:0102337 0.0396585 0.1343292 1.478584 724552 100578829 725031 552205 413789 3-oxo-cerotoyl-CoA synthase activity elongation of very long chain fatty acids protein AAEL008004-like; elongation of very long chain fatty acids protein 1-like; elongation of very long chain fatty acids protein 6; elongation of very long chain fatty acids protein AAEL008004; elongation of very long chain fatty acids protein AAEL008004-like
GO: Molecular function GO:0102338 0.0396585 0.1343292 1.478584 724552 100578829 725031 552205 413789 3-oxo-lignoceronyl-CoA synthase activity elongation of very long chain fatty acids protein AAEL008004-like; elongation of very long chain fatty acids protein 1-like; elongation of very long chain fatty acids protein 6; elongation of very long chain fatty acids protein AAEL008004; elongation of very long chain fatty acids protein AAEL008004-like
GO: Molecular function GO:0102756 0.0396585 0.1343292 1.478584 724552 100578829 725031 552205 413789 very-long-chain 3-ketoacyl-CoA synthase activity elongation of very long chain fatty acids protein AAEL008004-like; elongation of very long chain fatty acids protein 1-like; elongation of very long chain fatty acids protein 6; elongation of very long chain fatty acids protein AAEL008004; elongation of very long chain fatty acids protein AAEL008004-like
KEGG KEGG:00130 0.0064743 0.0773036 1.632588 412082 725400 Ubiquinone and other terpenoid-quinone biosynthesis ubiquinone biosynthesis O-methyltransferase, mitochondrial; 4-hydroxyphenylpyruvate dioxygenase
KEGG KEGG:04080 0.0118545 0.0922074 1.560081 410435 412740 413997 411323 412299 411611 412818 410654 406079 Neuroactive ligand-receptor interaction serotonin receptor; ligand-gated chloride channel homolog 3; translocator protein; serotonin receptor; muscarinic acetylcholine receptor DM1; tachykinin-like peptides receptor 99D; NMDA receptor 2; cholecystokinin receptor-like; NMDA receptor 1
KEGG KEGG:00061 0.0370928 0.1343292 1.479387 411959 409515 552286 551837 412815 Fatty acid biosynthesis fatty acid synthase-like; long-chain-fatty-acid–CoA ligase 4; acetyl-CoA carboxylase; long-chain-fatty-acid–CoA ligase ACSBG2; fatty acid synthase
KEGG KEGG:00640 0.0382217 0.1343292 1.427875 409150 413942 551958 409624 410325 552286 551403 551208 Propanoate metabolism enoyl Coenzyme A hydratase, short chain, 1, mitochondrial; acyl-CoA synthetase short-chain family member 3, mitochondrial; uncharacterized LOC551958; acetyl-coenzyme A synthetase; trifunctional enzyme subunit alpha, mitochondrial; acetyl-CoA carboxylase; succinyl-CoA ligase subunit alpha, mitochondrial; 3-hydroxyisobutyrate dehydrogenase, mitochondrial
KEGG KEGG:00790 0.0383548 0.1343292 1.466181 412015 551072 Folate biosynthesis 6-pyruvoyl tetrahydrobiopterin synthase; carbonyl reductase [NADPH] 1-like
KEGG KEGG:00630 0.0495742 0.1441111 1.413485 411541 409624 443552 411796 409485 Glyoxylate and dicarboxylate metabolism glycerate kinase; acetyl-coenzyme A synthetase; catalase; serine hydroxymethyltransferase; cytoplasmic aconitate hydratase-like

Lasius niger

Table S21: The results of GSEA (gene set enrichment analysis) for pheromone sensitivity in gene expression in Lasius niger. The table lists GO and KEGG terms with their NES (normalized enrichment score), the associated raw and adjusted p-values (adjustment was performed using Benjamini-Hochberg correction), and the genes underlying the enrichment result.

tab_S21 <- GO_and_KEGG_results_GSEA %>% 
  filter(Species == "ln" & pvalue < 0.05) %>%
  arrange(Test_type, pvalue) %>%
  select(-Species, -ES, -nMoreExtreme, -size) %>%
  add_name_col() 

saveRDS(tab_S21 %>% select(-enriched_gene_ids, -gene_names), file = "supplement/tab_S21.rds")
kable.table(tab_S21)
Test_type ID pvalue p.adjust NES enriched_gene_ids Description gene_names
GO: Biological process GO:0030163 0.0020053 0.0419353 -1.883620 551128 409198 410026 551343 551386 protein catabolic process 26S protease regulatory subunit 4; 26S protease regulatory subunit 6A-B; 26S proteasome regulatory complex subunit p48A; 26S protease regulatory subunit 7; 26S protease regulatory subunit 10B
GO: Biological process GO:0009058 0.0397614 0.1343292 1.449365 411916 724239 411959 biosynthetic process 2-amino-3-ketobutyrate coenzyme A ligase, mitochondrial; kynurenine/alpha-aminoadipate aminotransferase, mitochondrial-like; fatty acid synthase-like
GO: Cellular component GO:0000139 0.0033846 0.0497738 1.691075 410030 100576099 408983 725057 Golgi membrane protein SEC13 homolog; carbohydrate sulfotransferase 11-like; protein transport protein Sec23A; coatomer subunit beta
GO: Cellular component GO:0005576 0.0412082 0.1365156 1.321417 725217 726375 724246 410884 409241 410065 100577576 406083 409314 413481 413560 724880 551597 726057 724563 extracellular region uncharacterized protein PFB0145c-like; bone morphogenetic protein 2-B; growth/differentiation factor 2-like; phospholipase A1; prohormone-4; cuticular protein analogous to peritrophins 3-D; chondroitin proteoglycan-2-like; tachykinin; prohormone-2; probable chitinase 3; uncharacterized LOC413560; allatostatin A; cysteine-rich venom protein-like; insulin-like peptide 2; uncharacterized LOC724563
GO: Cellular component GO:0005680 0.0420468 0.1365156 -1.494161 413499 413293 409810 anaphase-promoting complex cell division cycle protein 23 homolog; anaphase-promoting complex subunit 10; anaphase-promoting complex subunit 4
GO: Molecular function GO:0036402 0.0014025 0.0350631 -1.880150 551128 409198 410026 551343 551386 proteasome-activating ATPase activity 26S protease regulatory subunit 4; 26S protease regulatory subunit 6A-B; 26S proteasome regulatory complex subunit p48A; 26S protease regulatory subunit 7; 26S protease regulatory subunit 10B
GO: Molecular function GO:0008146 0.0060634 0.0773036 1.608466 412996 100576099 sulfotransferase activity estrogen sulfotransferase; carbohydrate sulfotransferase 11-like
GO: Molecular function GO:0042302 0.0074711 0.0812075 1.587413 727197 726995 724624 724777 100576341 100577562 100577189 structural constituent of cuticle cuticular protein 2; endocuticle structural glycoprotein ABD-4; endocuticle structural glycoprotein SgAbd-1; cuticular protein 14; cuticular protein 16; probable LIM domain-containing serine/threonine-protein kinase DDB_G0286997; cuticular protein 6
GO: Molecular function GO:0005198 0.0100180 0.0863622 1.587925 410030 550716 725057 structural molecule activity protein SEC13 homolog; clathrin heavy chain; coatomer subunit beta
GO: Molecular function GO:0005509 0.0251975 0.1237232 1.349267 408672 410368 100577629 411647 408405 413977 409061 408937 551313 411659 409762 551859 551661 409881 409367 412825 calcium ion binding programmed cell death protein 6; cadherin-23; uncharacterized LOC100577629; calumenin; uncharacterized LOC408405; calsyntenin-1; tyrosine kinase receptor Cad96Ca; SPARC; calcineurin subunit B type 2; troponin C type I; sarcoplasmic calcium-binding protein 1; calmodulin; uncharacterized LOC551661; myosin regulatory light chain 2; calcyphosin-like protein; sushi, von Willebrand factor type A, EGF and pentraxin domain-containing protein 1
GO: Molecular function GO:0036459 0.0307918 0.1343292 -1.532409 411981 411572 410109 411362 409389 552660 408619 412114 thiol-dependent ubiquitinyl hydrolase activity probable ubiquitin carboxyl-terminal hydrolase FAF-X; ubiquitin carboxyl-terminal hydrolase 14; ubiquitin carboxyl-terminal hydrolase 34; ubiquitin carboxyl-terminal hydrolase 8-like; ubiquitin specific protease-like; ubiquitin carboxyl-terminal hydrolase 46; ubiquitin carboxyl-terminal hydrolase 3-like; ubiquitin carboxyl-terminal hydrolase 35-like
GO: Molecular function GO:0008536 0.0457143 0.1393728 -1.483124 413940 413344 413636 412817 726133 409992 411865 Ran GTPase binding importin-9; exportin-5; exportin-7; importin-4-like; exportin-6; importin-13; exportin-2
KEGG KEGG:01040 0.0020385 0.0419353 1.691761 412166 725031 552417 725146 Biosynthesis of unsaturated fatty acids acyl-CoA Delta(11) desaturase; elongation of very long chain fatty acids protein 6; acyl-CoA Delta(11) desaturase; very-long-chain enoyl-CoA reductase
KEGG KEGG:03050 0.0129090 0.0922074 1.475489 551550 409880 409609 409168 411695 409699 409668 Proteasome probable 26S proteasome non-ATPase regulatory subunit 3; 26S proteasome non-ATPase regulatory subunit 12; 26S proteasome non-ATPase regulatory subunit 4; 26S proteasome non-ATPase regulatory subunit 13; proteasome subunit beta type-1; 26S proteasome non-ATPase regulatory subunit 1-like; proteasome inhibitor PI31 subunit
KEGG KEGG:04080 0.0268860 0.1254808 1.423729 408995 412740 551388 411760 412011 411420 406079 726970 552518 412299 Neuroactive ligand-receptor interaction D2-like dopamine receptor; ligand-gated chloride channel homolog 3; adipokinetic hormone receptor; metabotropic glutamate receptor 7; probable muscarinic acetylcholine receptor gar-2; adenosine receptor A2b; NMDA receptor 1; cys-loop ligand-gated ion channel subunit 8916; serotonin receptor; muscarinic acetylcholine receptor DM1
KEGG KEGG:00260 0.0469274 0.1396648 1.401367 412674 411916 406081 552832 411796 411541 Glycine, serine and threonine metabolism phosphoserine phosphatase; 2-amino-3-ketobutyrate coenzyme A ligase, mitochondrial; glucose oxidase; glycine N-methyltransferase; serine hydroxymethyltransferase; glycerate kinase

GO and KEGG enrichment for differentially spliced genes

This section uses a metric that measures the sensitivity of alternative splicing to pheromone treatment (referred to in the code below as sensitivity). This metric is calculated by finding the highest and lowest log fold change in expression among the isoforms for gene \(i\), and then taking the difference. For example, a gene with two isoform, with log fold change values of -1 and +3, would have a sensitivity value of 4. In the following code, we calculate sensitivity for all of the genes which A) have orthologs in all 4 species, and B) have 2 or more isoforms. We then calculate the Spearman correlation in sensitivity across genes for each species pair, and also perform GSEA (as was previously done for the data on pheromone sensitivity).

# Calculate splicing sensitivity for Apis:
am_isoforms <- tbl(my_db, "ebseq_isoform_am") %>%
  left_join(tbl(my_db, "isoforms_am"), by = "isoform") %>% 
  arrange(gene) %>% collect()
# Discard genes with only one splice variant
keep <- am_isoforms %>% group_by(gene) %>% summarise(n_isoforms = n()) %>% filter(n_isoforms > 1) %>% .$gene 
am_isoforms <- am_isoforms %>% filter(gene %in% keep) %>%
  select(gene, PPDE, PostFC) 
# Splicing index is max - min of the log(FC) for the isoforms of the focal gene
am.splice <- am_isoforms %>% 
  split(.$gene) %>%
  purrr::map_dbl(function(x){
    max(log(x$PostFC)) - min(log(x$PostFC))
  }) 
am.splice <- data.frame(gene = names(am.splice),
                        sensitivity = unname(am.splice), stringsAsFactors = FALSE) %>%
  arrange(-sensitivity)

# Calculate splicing sensitivity for the other 3 species. Here, there is an extra step: map the genes to their Apis orthologs
get_splice_score <- function(sp){
  tabl <- paste("ebseq_isoform_", sp, sep = "")
  iso.table <- paste("isoforms_", sp, sep = "")
  ortho.table <- make.OGGs(c("am", sp))[[2]]
  
  isoforms <- tbl(my_db, tabl) %>%
    left_join(tbl(my_db, iso.table), by = "isoform") %>% collect(n=Inf) %>%
    arrange(gene) %>% 
    left_join(ortho.table, by = c("gene" = sp)) %>%
    select(-gene) %>% dplyr::rename(gene = am) %>%
    filter(!is.na(gene)) %>% collect()
  
  keep <- isoforms %>% group_by(gene) %>% summarise(n_isoforms = n()) %>% filter(n_isoforms > 1) %>% .$gene 
  
  isoforms <- isoforms %>% filter(gene %in% keep) %>%
    select(gene, PPDE, PostFC) 
  
  isoforms <- isoforms %>% 
    split(.$gene) %>%
    purrr::map_dbl(function(x){
      max(log(x$PostFC)) - min(log(x$PostFC))
    }) 
  data.frame(gene = names(isoforms), 
             sensitivity = unname(isoforms), stringsAsFactors = FALSE) %>%
    arrange(-sensitivity)
}

# Get the splicing index for all 4 species, and restrict to the set of genes that have orthologs in all 4 species 
splice_scores <- list(am.splice, 
                      get_splice_score("bt"), 
                      get_splice_score("lf"), 
                      get_splice_score("ln"))

# Find the correlations between each species pair in the splicing index
splicing_correlations <- data.frame(t(combn(1:4, 2)), rho = 0, p = 0) %>% 
  dplyr::rename(Species1 = X1, Species2 = X2)
for(i in 1:nrow(splicing_correlations)){
  focal <- left_join(splice_scores[[splicing_correlations[i, 1]]], 
                     splice_scores[[splicing_correlations[i, 2]]], by="gene")
  focal <- focal[complete.cases(focal), ]
  test <- with(focal, cor.test(sensitivity.x, sensitivity.y, method = "spearman"))
  splicing_correlations$rho[i] <- test$estimate
  splicing_correlations$p[i] <- test$p.value
}
splicing_correlations[,1] <- c("Apis mellifera", "Bombus terrestris", "Lasius flavus", "Lasius niger")[splicing_correlations[,1]]
splicing_correlations[,2] <- c("Apis mellifera", "Bombus terrestris", "Lasius flavus", "Lasius niger")[splicing_correlations[,2]]
splicing_correlations$p.adjust <- p.adjust(splicing_correlations$p, method = "BH")
splicing_correlations$sig <- " "
splicing_correlations$sig[splicing_correlations$p.adjust < 0.05] <- "*"

# Perform GSEA on the splicing index
GO_and_KEGG_splicing_GSEA <- rbind(
  GO.and.KEGG.gsea(df = splice_scores[[1]], keep.all = TRUE) %>% mutate(Species = "am"),
  GO.and.KEGG.gsea(df = splice_scores[[2]], keep.all = TRUE) %>% mutate(Species = "bt"), 
  GO.and.KEGG.gsea(df = splice_scores[[3]], keep.all = TRUE) %>% mutate(Species = "lf"), 
  GO.and.KEGG.gsea(df = splice_scores[[4]], keep.all = TRUE) %>% mutate(Species = "ln")) %>%
  fill_in_GSEA_results() 

Inter-species correlations in the sensitivity of alternative splicing to queen pheromone across pairs of orthologous genes

Table S22: The table shows the Spearman correlation (rho) and p-value for correlations across genes in the pheromone-sensitivity of their isoform production, for each pair of species. For each gene, our metric of the sensitivity of splicing to pheromone treatment was calculated by taking the difference between the highest and lowest log fold change values for the various isoforms. Thus, genes for which one isoform strongly increased in expression and one strongly decreased following pheromone treatment score high, and those in which there is no response to pheromone – or a consistent response for all isoforms – score low. The results suggest that the pheromone sensitivity in splicing is highly conserved between orthologous bee genes, and somewhat less conserved between orthologous ant genes, and between bee and ants genes.

saveRDS(splicing_correlations, file = "supplement/tab_S22.rds")
splicing_correlations %>% pander(split.cell = 40, split.table = Inf)
Species1 Species2 rho p p.adjust sig
Apis mellifera Bombus terrestris 0.1855 1.155e-08 6.927e-08 *
Apis mellifera Lasius flavus 0.06259 0.06836 0.1367
Apis mellifera Lasius niger 0.04333 0.153 0.1836
Bombus terrestris Lasius flavus 0.08915 0.01015 0.03045 *
Bombus terrestris Lasius niger 0.03039 0.2936 0.2936
Lasius flavus Lasius niger 0.04089 0.1499 0.1836

GSEA for pheromone sensitivity of alternative splicing

fig_S5 <- GO_and_KEGG_splicing_GSEA %>% make_enrichment_heatmap()
saveRDS(fig_S5, file = "supplement/fig_S5.rds")
fig_S5 %>% grid.draw()

Version Author Date
d5a6a73 lukeholman 2019-03-07
f260a62 Luke Holman 2019-03-07



Figure S5: Genes for which alternative splicing is strongly affected by queen pheromone tend to have similar Gene Ontology and KEGG terms in ants and bees, although the data do not provide strong evidence for or against inter-species similarity. The colour shows the normalised expression score from a GSEA (gene set enrichment analysis) test implemented in the R package fgsea; positive (red) values indicate that the GO or KEGG term is over-represented among genes whose splicing is strongly affected by queen pheromone, and negative (blue) values indicate under-representation among those genes. Asterisks denote statistically significant enrichment (p < 0.05), and double asterisks mark results that remained significant after adjusting the p-values for multiple testing using the Benjamini-Hochberg method. Empty squares denote cases where we did not find at least 5 alternatively spliced genes annotated with the focal term.

Tabular results for GSEA for pheromone sensitivity of alternative splicing

Table S23: The results of GSEA (gene set enrichment analysis) for pheromone sensitivity in alternative splicing. The table lists statistically significant GO and KEGG terms with their NES (normalized enrichment score), the associated raw and adjusted p-values (adjustment was performed using Benjamini-Hochberg correction), and the genes underlying each enrichment result.

tab_S23 <- GO_and_KEGG_splicing_GSEA %>% 
  filter(pvalue < 0.05) %>%
  arrange(Species, Test_type, pvalue) %>%
  select(-ES, -nMoreExtreme, -size) %>%
  add_name_col() 

saveRDS(tab_S23 %>% select(-gene_names, -enriched_gene_ids), file = "supplement/tab_S23.rds")
kable.table(tab_S23)
Test_type ID pvalue p.adjust NES enriched_gene_ids Description Species gene_names
GO: Cellular component GO:0005789 0.0371618 0.1390547 1.449603 411459 552377 413169 550724 endoplasmic reticulum membrane am sterol regulatory element-binding protein cleavage-activating protein; diacylglycerol O-acyltransferase 1; presenilin-1; 3-hydroxy-3-methylglutaryl-coenzyme A reductase
GO: Cellular component GO:0016592 0.0382692 0.1390547 1.452031 409749 550881 552719 mediator complex am mediator of RNA polymerase II transcription subunit 31; mediator of RNA polymerase II transcription subunit 8; mediator of RNA polymerase II transcription subunit 11
GO: Molecular function GO:0001104 0.0322844 0.1273924 1.455521 409749 550881 552719 RNA polymerase II transcription cofactor activity am mediator of RNA polymerase II transcription subunit 31; mediator of RNA polymerase II transcription subunit 8; mediator of RNA polymerase II transcription subunit 11
KEGG KEGG:04144 0.0044000 0.0725780 1.432046 409230 724991 413680 411585 411362 410923 413457 413464 411147 552297 551408 412601 409910 411723 409006 Endocytosis am arf-GAP with coiled-coil, ANK repeat and PH domain-containing protein 2; phosphatidylinositol 4-phosphate 5-kinase type-1 alpha; epsin-2; E3 ubiquitin-protein ligase NRDP1; ubiquitin carboxyl-terminal hydrolase 8-like; dynamin; zinc finger FYVE domain-containing protein 9; tyrosine-protein kinase Src64B; AP-2 complex subunit alpha; low density lipoprotein receptor adapter protein 1-B-like; uncharacterized LOC551408; mothers against decapentaplegic homolog 3; ras-like GTP-binding protein Rho1; E3 ubiquitin-protein ligase Nedd-4; arrestin red cell
KEGG KEGG:04745 0.0071499 0.0869908 1.597421 409020 551691 550818 410489 Phototransduction - fly am uncharacterized LOC409020; calcium/calmodulin-dependent protein kinase II; guanine nucleotide-binding protein G(q) subunit alpha; myosin-IIIb
KEGG KEGG:00630 0.0121013 0.0981553 1.552847 413678 726754 Glyoxylate and dicarboxylate metabolism am serine–pyruvate aminotransferase, mitochondrial; kynurenine formamidase
KEGG KEGG:04310 0.0231533 0.1145620 1.393171 551691 410190 412108 409286 409158 411046 413169 409910 551517 552805 Wnt signaling pathway am calcium/calmodulin-dependent protein kinase II; tyrosine-protein kinase Dnt; casein kinase I-like; stress-activated protein kinase JNK; C-terminal-binding protein; uncharacterized LOC411046; presenilin-1; ras-like GTP-binding protein Rho1; beta-TrCP; protein shifted
KEGG KEGG:00250 0.0251192 0.1145620 1.478191 413372 413678 551113 408991 724480 Alanine, aspartate and glutamate metabolism am putative glutamate synthase [NADPH]; serine–pyruvate aminotransferase, mitochondrial; delta-1-pyrroline-5-carboxylate dehydrogenase, mitochondrial; glutaminase kidney isoform, mitochondrial; asparagine synthetase [glutamine-hydrolyzing]
KEGG KEGG:00760 0.0390496 0.1390547 1.447503 551770 409487 408470 Nicotinate and nicotinamide metabolism am cytosolic purine 5’-nucleotidase; probable glutamine-dependent NAD(+) synthetase; NAD kinase-like
GO: Biological process GO:0007034 0.0205327 0.1145620 -1.584054 550738 411857 410607 410883 vacuolar transport bt NEDD4 family-interacting protein 1-like; charged multivesicular body protein 4b; charged multivesicular body protein 3; charged multivesicular body protein 6
GO: Biological process GO:0006351 0.0449834 0.1511387 1.363095 412010 410757 726204 409321 409227 411279 transcription, DNA-templated bt general transcription factor IIH subunit 4; circadian locomoter output cycles protein kaput; hairy/enhancer-of-split related with YRPW motif protein 1; mothers against decapentaplegic homolog 4; ultraspiracle; actin-related protein 8
GO: Biological process GO:0006412 0.0476190 0.1511387 -1.428849 724125 725943 552774 724631 413875 411862 550651 725147 413884 552097 552564 725854 552517 724708 412984 413137 409479 552106 412266 552676 translation bt 28S ribosomal protein S7, mitochondrial; ubiquitin-60S ribosomal protein L40; 60S ribosomal protein L28; 60S ribosomal protein L29; 60S ribosomal protein L31; 28S ribosomal protein S2, mitochondrial; 40S ribosomal protein S4; 40S ribosomal protein S29; ubiquitin-40S ribosomal protein S27a; 39S ribosomal protein L14, mitochondrial; 40S ribosomal protein S7; 39S ribosomal protein L37, mitochondrial; 60S ribosomal protein L13; 39S ribosomal protein L23, mitochondrial; 28S ribosomal protein S30, mitochondrial; 60S ribosomal protein L15; 60S ribosomal protein L6; uncharacterized LOC552106; 60S ribosomal protein L27; 39S ribosomal protein L3, mitochondrial
GO: Cellular component GO:0005886 0.0032006 0.0725780 1.537862 100578210 100577938 100577446 100577755 725297 100578083 100577334 411760 100578230 725205 551782 plasma membrane bt odorant receptor 5; odorant receptor 18; odorant receptor 27; odorant receptor 30a-like; gustatory receptor 10; odorant receptor 14; odorant receptor 33; metabotropic glutamate receptor 7; odorant receptor 115; odorant receptor 1; bestrophin-4-like
GO: Cellular component GO:0005576 0.0110065 0.0977523 1.562965 409307 409553 extracellular region bt uncharacterized LOC409307; pancreatic triacylglycerol lipase-like
GO: Molecular function GO:0046983 0.0110406 0.0977523 1.535076 410757 726204 410953 protein dimerization activity bt circadian locomoter output cycles protein kaput; hairy/enhancer-of-split related with YRPW motif protein 1; MLX-interacting protein
GO: Molecular function GO:0003735 0.0227273 0.1145620 -1.444564 724125 725943 552774 724631 413875 411862 550651 725147 413884 552097 552564 725854 552517 724708 412984 413137 409479 552106 412266 552676 structural constituent of ribosome bt 28S ribosomal protein S7, mitochondrial; ubiquitin-60S ribosomal protein L40; 60S ribosomal protein L28; 60S ribosomal protein L29; 60S ribosomal protein L31; 28S ribosomal protein S2, mitochondrial; 40S ribosomal protein S4; 40S ribosomal protein S29; ubiquitin-40S ribosomal protein S27a; 39S ribosomal protein L14, mitochondrial; 40S ribosomal protein S7; 39S ribosomal protein L37, mitochondrial; 60S ribosomal protein L13; 39S ribosomal protein L23, mitochondrial; 28S ribosomal protein S30, mitochondrial; 60S ribosomal protein L15; 60S ribosomal protein L6; uncharacterized LOC552106; 60S ribosomal protein L27; 39S ribosomal protein L3, mitochondrial
GO: Molecular function GO:0004672 0.0267296 0.1145620 1.453553 408664 408533 413759 413190 551773 412747 protein kinase activity bt homeodomain-interacting protein kinase 2; mitogen-activated protein kinase kinase kinase 15; SCY1-like protein 2; calcium-dependent protein kinase 4-like; serine/threonine-protein kinase VRK1-like; receptor interacting protein kinase 5
GO: Molecular function GO:0004252 0.0466352 0.1511387 1.396669 726126 410438 724145 413645 724917 410894 724308 411358 409143 726718 serine-type endopeptidase activity bt proclotting enzyme; neuroendocrine convertase 1-like; transmembrane protease serine 9; trypsin alpha-3; uncharacterized LOC724917; chymotrypsin-1; trypsin-1; trypsin-1; venom serine protease 34; rhomboid-related protein 4-like
KEGG KEGG:00534 0.0049711 0.0725780 1.595536 551445 413271 408293 Glycosaminoglycan biosynthesis - heparan sulfate / heparin bt heparin sulfate O-sulfotransferase; galactosylgalactosylxylosylprotein 3-beta-glucuronosyltransferase I; exostosin-1
KEGG KEGG:04214 0.0177298 0.1145620 1.471707 725245 551969 409227 409286 408533 408758 Apoptosis - fly bt protein eiger-like; serine protease HTRA2, mitochondrial; ultraspiracle; stress-activated protein kinase JNK; mitogen-activated protein kinase kinase kinase 15; ecdysteroid-regulated gene E74
KEGG KEGG:04350 0.0207798 0.1145620 1.488501 410035 411627 409321 412866 TGF-beta signaling pathway bt dorsal-ventral patterning protein Sog; retinoblastoma-like protein 1; mothers against decapentaplegic homolog 4; E3 ubiquitin-protein ligase SMURF2
KEGG KEGG:03010 0.0370370 0.1390547 -1.340568 724125 725943 552774 724631 413875 409552 411862 550651 725147 552097 725168 552564 552517 724708 413137 409479 552106 412266 552676 Ribosome bt 28S ribosomal protein S7, mitochondrial; ubiquitin-60S ribosomal protein L40; 60S ribosomal protein L28; 60S ribosomal protein L29; 60S ribosomal protein L31; 40S ribosomal protein S10-like; 28S ribosomal protein S2, mitochondrial; 40S ribosomal protein S4; 40S ribosomal protein S29; 39S ribosomal protein L14, mitochondrial; ribosomal protein S14; 40S ribosomal protein S7; 60S ribosomal protein L13; 39S ribosomal protein L23, mitochondrial; 60S ribosomal protein L15; 60S ribosomal protein L6; uncharacterized LOC552106; 60S ribosomal protein L27; 39S ribosomal protein L3, mitochondrial
GO: Molecular function GO:0030170 0.0048622 0.0725780 1.641783 724919 411796 408509 408817 410583 408432 pyridoxal phosphate binding lf mitochondrial amidoxime reducing component 2-like; serine hydroxymethyltransferase; glutamate decarboxylase 1; alanine–glyoxylate aminotransferase 2-like; ornithine aminotransferase, mitochondrial; glutamate decarboxylase
GO: Molecular function GO:0004252 0.0079400 0.0891724 1.592918 725154 409459 412319 409204 412293 serine-type endopeptidase activity lf serine protease snake; lon protease homolog, mitochondrial; rhomboid-related protein 2; trypsin; membrane-bound transcription factor site-1 protease
KEGG KEGG:00190 0.0024240 0.0725780 1.681785 409103 408367 Oxidative phosphorylation lf protoheme IX farnesyltransferase, mitochondrial; NADH dehydrogenase [ubiquinone] flavoprotein 1, mitochondrial
KEGG KEGG:00860 0.0026977 0.0725780 1.681653 409103 494506 409922 Porphyrin and chlorophyll metabolism lf protoheme IX farnesyltransferase, mitochondrial; heme oxygenase; ferrochelatase, mitochondrial
KEGG KEGG:03010 0.0113821 0.0977523 -1.827766 724125 411103 411380 413398 409832 552517 413868 725201 725062 Ribosome lf 28S ribosomal protein S7, mitochondrial; putative 28S ribosomal protein S5, mitochondrial; 60S ribosomal protein L30; 39S ribosomal protein L32, mitochondrial; 60S ribosomal protein L18a; 60S ribosomal protein L13; 60S ribosomal protein L10a; 39S ribosomal protein L21, mitochondrial; 39S ribosomal protein L4, mitochondrial
KEGG KEGG:04624 0.0274635 0.1145620 1.459957 406086 725832 551608 725154 724703 Toll and Imd signaling pathway lf dorsal; beta-1,3-glucan-binding protein 1; serine/threonine-protein kinase pelle; serine protease snake; coagulation factor X
KEGG KEGG:01100 0.0467953 0.1511387 1.162914 409444 409103 413119 409276 494506 550970 408441 412731 408299 552086 411140 410828 727004 100577378 552823 551853 409515 727189 411796 552771 409499 100577053 726824 412170 408509 409614 409329 410330 408817 552522 413255 551419 413411 412541 412548 411633 411662 410583 551208 408432 411372 409224 410080 552007 552421 727456 413664 551749 410530 411563 408730 552533 413643 551005 551041 408809 410554 725665 551403 410627 409250 552556 726216 409494 409270 408883 551578 550785 409922 724718 724550 412341 412815 412674 552130 406107 727300 410118 409861 410071 550885 551762 552657 410132 724361 724991 725817 413705 100577717 Metabolic pathways lf AMP deaminase 2; protoheme IX farnesyltransferase, mitochondrial; heparan-alpha-glucosaminide N-acetyltransferase-like; phosphatidylinositol 5-phosphate 4-kinase type-2 alpha; heme oxygenase; lysophosphatidylcholine acyltransferase-like; adenosine kinase 1; type II inositol 1,4,5-trisphosphate 5-phosphatase; purine nucleoside phosphorylase; aldose 1-epimerase; putative aldehyde dehydrogenase family 7 member A1 homolog; tryptophan 2,3-dioxygenase; putative glutathione-specific gamma-glutamylcyclotransferase 2; galactokinase-like; malonyl-CoA decarboxylase, mitochondrial-like; STT3, subunit of the oligosaccharyltransferase complex, homolog B; long-chain-fatty-acid–CoA ligase 4; geranylgeranyl pyrophosphate synthase; serine hydroxymethyltransferase; hydroxyacid oxidase 1; UDP-glucose 4-epimerase-like; glycine dehydrogenase (decarboxylating), mitochondrial; putative inositol monophosphatase 3; putative neutral sphingomyelinase; glutamate decarboxylase 1; group XIIA secretory phospholipase A2; mannose-1-phosphate guanyltransferase beta; phosphatidylserine synthase 1; alanine–glyoxylate aminotransferase 2-like; alpha-(1,6)-fucosyltransferase; 2-methoxy-6-polyprenyl-1,4-benzoquinol methylase, mitochondrial; alkaline ceramidase; myotubularin-related protein 14; long-chain-fatty-acid–CoA ligase 6; 2-oxoisovalerate dehydrogenase subunit alpha, mitochondrial; UDP-glucose 4-epimerase; probable trans-2-enoyl-CoA reductase, mitochondrial; ornithine aminotransferase, mitochondrial; 3-hydroxyisobutyrate dehydrogenase, mitochondrial; glutamate decarboxylase; glutathione synthetase-like; ubiquinone biosynthesis protein COQ7; spermine synthase; pyruvate kinase; glycogenin-1; glucose-6-phosphate 1-epimerase; GPI transamidase component PIG-S; glycosyltransferase-like protein LARGE1; alkaline phosphatase-like; myotubularin-related protein 2; inositol polyphosphate 5-phosphatase K-like; GDP-Man:Man(3)GlcNAc(2)-PP-Dol alpha-1,2-mannosyltransferase; N-acetylglucosaminyl-phosphatidylinositol biosynthetic protein; hexokinase type 2; glycerol kinase; diacylglycerol kinase theta; methylcrotonoyl-CoA carboxylase beta chain, mitochondrial; 5-oxoprolinase; succinyl-CoA ligase subunit alpha, mitochondrial; putative aminopeptidase W07G4.4; beta-ureidopropionase; arginase-1; exostosin-2; methylglutaconyl-CoA hydratase, mitochondrial; glycerol-3-phosphate acyltransferase 4; deoxycytidylate deaminase; protein O-mannosyl-transferase 2; fructose-bisphosphate aldolase; ferrochelatase, mitochondrial; xanthine dehydrogenase; iduronate 2-sulfatase; alpha-methylacyl-CoA racemase; fatty acid synthase; phosphoserine phosphatase; alpha-aminoadipic semialdehyde synthase, mitochondrial; glucosamine-fructose-6-phosphate aminotransferase 2; low molecular weight phosphotyrosine protein phosphatase-like; D-glucuronyl C5-epimerase; nucleoside diphosphate kinase; glycerol-3-phosphate phosphatase-like; nicotinate phosphoribosyltransferase; adenosylhomocysteinase 2-like; phosphoribosylformylglycinamidine synthase; GPI transamidase component PIG-T; GPI inositol-deacylase; phosphatidylinositol 4-phosphate 5-kinase type-1 alpha; diphosphomevalonate decarboxylase; acidic mammalian chitinase-like; uncharacterized LOC100577717
GO: Biological process GO:0007034 0.0242511 0.1145620 -1.627514 410607 552786 550738 411857 410883 vacuolar transport ln charged multivesicular body protein 3; charged multivesicular body protein 2a; NEDD4 family-interacting protein 1-like; charged multivesicular body protein 4b; charged multivesicular body protein 6
GO: Biological process GO:0005975 0.0289666 0.1174757 1.386429 551785 409267 411100 409884 552381 726210 551447 412362 726095 406114 411897 409199 412245 727456 carbohydrate metabolic process ln 6-phosphogluconolactonase; glycogen phosphorylase; FGGY carbohydrate kinase domain-containing protein; xylulose kinase; neutral and basic amino acid transport protein rBAT; uncharacterized family 31 glucosidase KIAA1161; mannose-6-phosphate isomerase; glucose 1,6-bisphosphate synthase; galactoside 2-alpha-L-fucosyltransferase 2-like; alpha-amylase; phosphoglucomutase; glycerol kinase; acidic mammalian chitinase; glucose-6-phosphate 1-epimerase
GO: Cellular component GO:0005794 0.0228188 0.1145620 -1.587668 412710 411970 412913 409613 411408 Golgi apparatus ln trafficking protein particle complex subunit 3; G kinase-anchoring protein 1-like; Golgi SNAP receptor complex member 2; GTP-binding protein SAR1; CDP-diacylglycerol–inositol 3-phosphatidyltransferase
GO: Cellular component GO:0005886 0.0241376 0.1145620 1.511492 409650 551165 552552 406124 551508 725384 551388 plasma membrane ln solute carrier organic anion transporter family member 2A1; innexin inx3; uncharacterized LOC552552; gamma-aminobutyric acid receptor subunit beta; vang-like protein 1; odorant receptor 2; adipokinetic hormone receptor
GO: Molecular function GO:0030170 0.0185166 0.1145620 1.478569 411796 409267 409927 724919 pyridoxal phosphate binding ln serine hydroxymethyltransferase; glycogen phosphorylase; putative pyridoxal-dependent decarboxylase domain-containing protein 2; mitochondrial amidoxime reducing component 2-like
GO: Molecular function GO:0009055 0.0191898 0.1145620 -1.590390 413605 727309 552386 409549 552835 410308 408270 551039 551169 551710 electron transfer activity ln cytochrome c1, heme protein, mitochondrial; glutaredoxin-C4; anamorsin homolog; succinate dehydrogenase cytochrome b560 subunit, mitochondrial; glutaredoxin-related protein 5, mitochondrial; electron transfer flavoprotein subunit beta; mitochondrial cytochrome C; dihydrolipoyl dehydrogenase, mitochondrial; succinate dehydrogenase [ubiquinone] iron-sulfur subunit, mitochondrial-like; electron transfer flavoprotein subunit alpha, mitochondrial
GO: Molecular function GO:0005198 0.0268312 0.1145620 1.488230 550716 410030 725057 412083 structural molecule activity ln clathrin heavy chain; protein SEC13 homolog; coatomer subunit beta; coatomer subunit gamma
GO: Molecular function GO:0003924 0.0472047 0.1511387 1.289588 406098 411351 551731 409529 413943 550723 410241 410969 410906 551185 413034 411542 410414 413614 411472 409126 410157 GTPase activity ln translation initiation factor 2; elongation factor G, mitochondrial; rho GTPase-activating protein 190; ras-like protein 2; eukaryotic peptide chain release factor GTP-binding subunit ERF3A; ras-related protein Rab-39B; ras-related protein Rab-10; ras-related protein Rab-9A; guanine nucleotide-binding protein subunit alpha homolog; GTP-binding protein 1; rho-related BTB domain-containing protein 1; signal recognition particle receptor subunit alpha homolog; 116 kDa U5 small nuclear ribonucleoprotein component; ras-related protein Rab-14; dynamin-1-like protein; ras-related protein Rab-2; ras-related protein Rab-23
KEGG KEGG:01230 0.0002005 0.0219000 1.671990 411796 413867 552007 412876 550785 550804 550767 408859 Biosynthesis of amino acids ln serine hydroxymethyltransferase; transaldolase; pyruvate kinase; pyruvate carboxylase, mitochondrial; fructose-bisphosphate aldolase; transketolase; ribose 5-phosphate isomerase A; pyrroline-5-carboxylate reductase 2
KEGG KEGG:01200 0.0003000 0.0219000 1.597283 411796 551785 413867 552007 412876 409624 550785 550804 550767 550667 Carbon metabolism ln serine hydroxymethyltransferase; 6-phosphogluconolactonase; transaldolase; pyruvate kinase; pyruvate carboxylase, mitochondrial; acetyl-coenzyme A synthetase; fructose-bisphosphate aldolase; transketolase; ribose 5-phosphate isomerase A; succinate dehydrogenase [ubiquinone] flavoprotein subunit, mitochondrial
KEGG KEGG:00030 0.0012452 0.0605998 1.711683 551785 413867 550785 550804 550767 Pentose phosphate pathway ln 6-phosphogluconolactonase; transaldolase; fructose-bisphosphate aldolase; transketolase; ribose 5-phosphate isomerase A
KEGG KEGG:00260 0.0035281 0.0725780 1.638785 411796 406081 410432 Glycine, serine and threonine metabolism ln serine hydroxymethyltransferase; glucose oxidase; L-threonine 3-dehydrogenase, mitochondrial
KEGG KEGG:00040 0.0061873 0.0821217 1.612270 551968 409884 Pentose and glucuronate interconversions ln aldose reductase-like; xylulose kinase
KEGG KEGG:04140 0.0108011 0.0977523 1.393260 552756 413663 409529 413153 408501 409393 726637 552038 412687 100578537 409941 413668 413430 551198 552315 551668 551057 724873 409577 Autophagy - animal ln cathepsin L1; myotubularin-related protein 4; ras-like protein 2; uncharacterized LOC413153; serine/threonine-protein kinase/endoribonuclease IRE1; serine/threonine-protein kinase mTOR; ubiquitin-like modifier-activating enzyme atg7; synaptosomal-associated protein 29; beclin 1-associated autophagy-related key regulator; UV radiation resistance-associated gene protein; zinc finger FYVE domain-containing protein 1-like; run domain Beclin-1-interacting and cysteine-rich domain-containing protein; RAC serine/threonine-protein kinase; serine/threonine-protein kinase STK11; ubiquitin-like-conjugating enzyme ATG3; regulatory-associated protein of mTOR; autophagy protein 5; ras-related protein Rab-7a; 5’-AMP-activated protein kinase catalytic subunit alpha-2
KEGG KEGG:01100 0.0154985 0.1145620 1.156148 411796 551785 413867 550932 406081 552007 412876 551762 409624 409267 551968 413987 410980 412393 412541 413071 413663 550785 413233 411525 409884 409487 408470 551314 550804 550884 550767 551712 410096 408373 408868 726156 550667 725146 551721 725119 552755 408859 726310 411563 552421 409473 410798 409299 408930 551667 412273 727293 409329 552522 411188 551093 409515 408546 724361 552086 725623 551578 408461 413655 410627 410076 413340 551958 726747 406080 726239 724666 551447 551866 409270 552699 412362 408809 411959 413879 412632 552342 726095 409860 552496 408288 411692 552286 408441 408817 406114 413735 409155 412328 409250 411581 551182 412467 411897 409614 552533 551103 408969 409199 551964 409861 411698 551841 412426 100577378 413228 724239 413854 412245 727071 409846 409276 552180 724811 551102 727456 100577053 410059 726818 410105 551662 410396 552557 551593 412675 551837 412815 724436 406076 551775 408446 411447 100187709 412782 408991 411411 552023 Metabolic pathways ln serine hydroxymethyltransferase; 6-phosphogluconolactonase; transaldolase; arginine kinase; glucose oxidase; pyruvate kinase; pyruvate carboxylase, mitochondrial; adenosylhomocysteinase 2-like; acetyl-coenzyme A synthetase; glycogen phosphorylase; aldose reductase-like; polypeptide N-acetylgalactosaminyltransferase 5; polyphosphoinositide phosphatase; cytosolic non-specific dipeptidase; long-chain-fatty-acid–CoA ligase 6; eye-specific diacylglycerol kinase; myotubularin-related protein 4; fructose-bisphosphate aldolase; methylcrotonoyl-CoA carboxylase subunit alpha, mitochondrial; choline/ethanolamine kinase; xylulose kinase; probable glutamine-dependent NAD(+) synthetase; NAD kinase-like; heparan-alpha-glucosaminide N-acetyltransferase-like; transketolase; N-sulphoglucosamine sulphohydrolase; ribose 5-phosphate isomerase A; lipoyltransferase 1, mitochondrial; gamma-glutamyltranspeptidase 1-like; phosphatidylinositol 4-kinase beta; inositol monophosphatase 2-like; pantothenate kinase 3; succinate dehydrogenase [ubiquinone] flavoprotein subunit, mitochondrial; very-long-chain enoyl-CoA reductase; V-type proton ATPase subunit B; phospholipase D2; probable GDP-L-fucose synthase; pyrroline-5-carboxylate reductase 2; GPI ethanolamine phosphate transferase 1-like; myotubularin-related protein 2; glycogenin-1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; DNA methyltransferase 3; adenylosuccinate synthetase; tyrosine hydroxylase; bifunctional methylenetetrahydrofolate dehydrogenase/cyclohydrolase, mitochondrial; probable chitinase 3; guanine deaminase; mannose-1-phosphate guanyltransferase beta; alpha-(1,6)-fucosyltransferase; L-lactate dehydrogenase-like; V-type proton ATPase catalytic subunit A; long-chain-fatty-acid–CoA ligase 4; phosphatidylinositide phosphatase SAC2; GPI inositol-deacylase; aldose 1-epimerase; heparanase-like; protein O-mannosyl-transferase 2; uridine 5’-monophosphate synthase; 3-oxoacyl-[acyl-carrier-protein] synthase, mitochondrial; putative aminopeptidase W07G4.4; probable uridine-cytidine kinase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 10, mitochondrial; uncharacterized LOC551958; cytochrome b-c1 complex subunit 8; polycomblike; putative lipoyltransferase 2, mitochondrial; 2-aminoethanethiol dioxygenase; mannose-6-phosphate isomerase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 9, mitochondrial; glycerol-3-phosphate acyltransferase 4; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; glucose 1,6-bisphosphate synthase; diacylglycerol kinase theta; fatty acid synthase-like; CDP-diacylglycerol–glycerol-3-phosphate 3-phosphatidyltransferase, mitochondrial; adenylate kinase 1; lysophospholipid acyltransferase 2; galactoside 2-alpha-L-fucosyltransferase 2-like; GPI ethanolamine phosphate transferase 3; polypeptide N-acetylgalactosaminyltransferase 35A-like; isovaleryl-CoA dehydrogenase, mitochondrial; elongation of very long chain fatty acids protein 4-like; acetyl-CoA carboxylase; adenosine kinase 1; alanine–glyoxylate aminotransferase 2-like; alpha-amylase; glutamate–cysteine ligase regulatory subunit; dihydrolipoyllysine-residue succinyltransferase component of 2-oxoglutarate dehydrogenase complex, mitochondrial-like; NADH dehydrogenase [ubiquinone] iron-sulfur protein 6, mitochondrial; beta-ureidopropionase; phosphopantothenate–cysteine ligase; phosphatidylinositol 4-kinase alpha; bifunctional purine biosynthesis protein PURH; phosphoglucomutase; group XIIA secretory phospholipase A2; GDP-Man:Man(3)GlcNAc(2)-PP-Dol alpha-1,2-mannosyltransferase; probable pyruvate dehydrogenase E1 component subunit alpha, mitochondrial; aminoacylase-1-like; glycerol kinase; UDP-N-acetylhexosamine pyrophosphorylase; nucleoside diphosphate kinase; ethanolaminephosphotransferase 1-like; probable dolichyl pyrophosphate Glc1Man9GlcNAc2 alpha-1,3-glucosyltransferase; ubiquinone biosynthesis monooxygenase COQ6, mitochondrial; galactokinase-like; 5-aminolevulinate synthase, erythroid-specific, mitochondrial; kynurenine/alpha-aminoadipate aminotransferase, mitochondrial-like; xylosyltransferase oxt; acidic mammalian chitinase; acylglycerol kinase, mitochondrial; GMP synthase [glutamine-hydrolyzing]; phosphatidylinositol 5-phosphate 4-kinase type-2 alpha; cob(I)yrinic acid a,c-diamide adenosyltransferase, mitochondrial-like; kynurenine–oxoglutarate transaminase 3-like; S-adenosylmethionine synthase; glucose-6-phosphate 1-epimerase; glycine dehydrogenase (decarboxylating), mitochondrial; probable citrate synthase 2, mitochondrial; beta-hexosaminidase subunit beta-like; alpha-1,3-mannosyl-glycoprotein 2-beta-N-acetylglucosaminyltransferase; beta-1,4-galactosyltransferase 7; isocitrate dehydrogenase [NAD] subunit gamma, mitochondrial; lipoamide acyltransferase component of branched-chain alpha-keto acid dehydrogenase complex, mitochondrial; sphingosine-1-phosphate lyase; aspartate aminotransferase, mitochondrial; long-chain-fatty-acid–CoA ligase ACSBG2; fatty acid synthase; phospholipase A2-like; vacuolar H+ ATP synthase 16 kDa proteolipid subunit; trifunctional enzyme subunit beta, mitochondrial; probable aconitate hydratase, mitochondrial; serine palmitoyltransferase 2; nicotinamide riboside kinase; nucleoside diphosphate kinase 7; glutaminase kidney isoform, mitochondrial; NADH dehydrogenase [ubiquinone] iron-sulfur protein 3, mitochondrial; guanylate kinase
KEGG KEGG:00051 0.0188415 0.1145620 1.519598 551968 550785 552755 409329 551447 Fructose and mannose metabolism ln aldose reductase-like; fructose-bisphosphate aldolase; probable GDP-L-fucose synthase; mannose-1-phosphate guanyltransferase beta; mannose-6-phosphate isomerase
KEGG KEGG:00630 0.0253139 0.1145620 1.455054 411796 409624 Glyoxylate and dicarboxylate metabolism ln serine hydroxymethyltransferase; acetyl-coenzyme A synthetase

GO and KEGG enrichment for transcriptional modules

Here, we use hypergeometric tests on each of the 9 modules, testing for enrichment of GO terms in each module.

# Find the names for the genes in a given module
genes.in.module <- function(module.number){
  colnames(OGGs[[1]])[network[[1]]$colors == paste("Module", module.number)] 
}

# Get the gene names, and sensitivity to pheromone, for genes in a certain module
inspect.module.genes <- function(module){
  gene.names <- tbl(my_db, "bee_names") %>% as.data.frame()
  gene.names <- gene.names[gene.names$gene %in% genes.in.module(module), ]
  gene.names$k <- colSums(as.matrix(TOM)[network[[1]]$colors == paste("Module", module), 
                                        network[[1]]$colors == paste("Module", module)])
  gene.names <- gene.names %>% arrange(-k)
  
  am <- tbl(my_db, "ebseq_gene_am") %>% as.data.frame()
  gene.names$am_fc <- am$PostFC[match(gene.names$gene, am$gene)]
  bt <- tbl(my_db, "ebseq_gene_bt") %>% rename(bt = gene) %>% 
    left_join(tbl(my_db, "bt2am")) %>% as.data.frame()
  gene.names$bt_fc <- bt$PostFC[match(gene.names$gene, bt$am)]
  lf <- tbl(my_db, "ebseq_gene_lf") %>% rename(lf = gene) %>% 
    left_join(tbl(my_db, "lf2am")) %>% as.data.frame()
  gene.names$lf_fc <- lf$PostFC[match(gene.names$gene, lf$am)]
  ln <- tbl(my_db, "ebseq_gene_ln") %>% rename(ln = gene) %>% 
    left_join(tbl(my_db, "ln2am")) %>% as.data.frame()
  gene.names$ln_fc <- ln$PostFC[match(gene.names$gene, ln$am)]
  row.names(gene.names) <- NULL
  gene.names
}


GO.and.KEGG.hypergeometric <- function(gene_set, gene_universe, apis.db, min.size = 5, keep.all = FALSE){
  
  p <- 0.05; if(keep.all) p <- 1
  neatness <- function(x) format(round(x, 4), nsmall = 4) # for rounding
  
  GO.enrichment <- function(gene_set, gene_universe, ontol){
    
    result <- enrichGO(gene_set, apis.db, ont = ontol, 
                       pvalueCutoff = p, universe = gene_universe, 
                       qvalueCutoff = 1, minGSSize = min.size, maxGSSize = 500) 
    
    if(is.null(result)) return(NULL)
    if(nrow(result@result) == 0) return(NULL)
    result <- gofilter(result, level = 4) # Filter to high-level GO only
    if(is.null(result)) return(NULL)
    if(nrow(result@result) == 0) return(NULL)
    
    result <- result@result 
    is_enriched <- sapply(result$GeneRatio, function(x) eval(parse(text=x))) > sapply(result$BgRatio, function(x) eval(parse(text=x)))
    result <- result[is_enriched, ] %>% mutate(p.adjust = p.adjust(pvalue, method = "BH"))
    
    Test_type <- "GO: Biological process"
    if(ontol == "MF") Test_type <- "GO: Molecular function"
    if(ontol == "CC") Test_type <- "GO: Cellular component"
    
    data.frame(Test_type = Test_type, result, stringsAsFactors = FALSE)
  }
  
  kegg.enrichment <- function(gene_set, gene_universe){
    
    
    result <-  enrichKEGG(gene_set, organism = "ame", keyType = "kegg", pvalueCutoff = p,
                          gene_universe, minGSSize = min.size, maxGSSize = 500,
                          qvalueCutoff = 1, use_internal_data = FALSE, pAdjustMethod = "BH")
    if(is.null(result)) return(NULL)
    
    result <- result@result
    is_enriched <- sapply(result$GeneRatio, function(x) eval(parse(text=x))) > sapply(result$BgRatio, function(x) eval(parse(text=x)))
    result <- result[is_enriched, ] %>% mutate(p.adjust = p.adjust(pvalue, method = "BH"))
    if(nrow(result %>% filter(pvalue < p)) == 0) return(NULL)
    data.frame(Test_type = "KEGG", result, stringsAsFactors = FALSE)
  }
  
  rbind(kegg.enrichment(gene_set, gene_universe), 
                  GO.enrichment(gene_set, gene_universe, "BP"),
                  GO.enrichment(gene_set, gene_universe, "MF"),
                  GO.enrichment(gene_set, gene_universe, "CC")) %>%
    mutate(ID = str_replace_all(ID, "ame", "KEGG:"),
           geneID = str_replace_all(geneID, "/", " "))
}


make_module_GO_table <- function(){
  
  add_name_col <- function(df){
    sapply(df$geneID, function(x){
      data.frame(gene = x, stringsAsFactors = FALSE) %>%
        left_join(tbl(my_db, "apis_entrez_names") %>% collect(), by = c("gene" = "entrez")) %>% .$name %>%
        paste0(collapse = "; ")
    }) -> df$gene_names
    df %>% mutate(geneID = map_chr(geneID, function(x) paste0(x, collapse = " ")))
  }
  
  hub <- AnnotationHub::AnnotationHub()
  select <- dplyr::select
  rename <- dplyr::rename
  filter <- dplyr::filter
  apis.db <- hub[["AH62534"]]
  gene.universe.modules <- entrez.tbl$entrez.id[entrez.tbl$gene %in% OGGs[[2]]$am] %>% as.character() 
  
  results <- lapply(1:9, function(i) { # or c(1,4,9)
    gene_set <- entrez.tbl$entrez.id[entrez.tbl$gene %in% genes.in.module(i)] %>% as.character()
  
    df <- GO.and.KEGG.hypergeometric(gene_set, gene.universe.modules, apis.db) 
    if(is.null(df) || nrow(df) == 0) return(NULL)
    # # enrichment ratio: proportion genes in sample / proportion in gene universe
    df$enrichment <- sapply(1:nrow(df), function(i) eval(parse(text = df$GeneRatio[i]))) /
      sapply(1:nrow(df), function(i) eval(parse(text = df$BgRatio[i])))
    df %>% mutate(Module = paste("Module", i)) %>% arrange(pvalue)
  }) %>% do.call("rbind", .) %>%
  mutate(Description = factor(Description, unique(Description))) %>% 
    filter(pvalue <= 0.05) # Only keep GO terms where the un-adjusted p is significant
  
  results$sig <- "no"  # Use a more strict classification, since the test has higher power
  results$sig[results$p.adjust <= 0.05] <- "yes" # note: ADJUSTED p
  results$sig <- relevel(factor(results$sig), ref = "yes")
  results <- select(results, Module, Test_type, ID, Description, GeneRatio, BgRatio, 
                    enrichment, pvalue, p.adjust, qvalue, Count, geneID, sig)
  
  results$geneID <- strsplit(results$geneID, split = " ")
  results %>% add_name_col()
}

module_enrichment_plot <- function(df, is.KEGG = FALSE){
  label <- "Name of GO term"
  if(is.KEGG) label <- "Name of KEGG term"
  df %>% arrange(Module, log2(enrichment)) %>% 
    mutate(Description = factor(Description, unique(Description)),
           Test_type = factor(Test_type, c("GO: Biological process", "GO: Molecular function", "GO: Cellular component", "KEGG"))) %>%
    ggplot(aes(Description, log2(enrichment))) + 
    geom_bar(aes(fill = sig), stat = "identity", colour = "grey10") + 
    facet_wrap(~Module) + 
    scale_fill_brewer(palette = "Accent", direction = -1) + 
    scale_x_discrete(labels = function(x) str_wrap(x, width = 60)) +
    theme_bw() +
    theme(legend.position = "none", strip.background = element_blank(), strip.text = element_text(size = 10)) + 
    ylab("Log2 fold enrichment") + xlab(label) + 
    coord_flip() 
}  

module_GO_table <- make_module_GO_table()

Figures of the module enrichment results

KEGG

module_KEGG <- module_GO_table %>% filter(Test_type == "KEGG", Module %in% c("Module 1", "Module 4", "Module 9")) %>% 
   module_enrichment_plot(is.KEGG = TRUE)
ggsave(module_KEGG, file = "figures/Figure 4 - module KEGG.pdf", height = 7, width = 8)
module_KEGG

Version Author Date
f260a62 Luke Holman 2019-03-07



Figure 4: Results of KEGG pathway enrichment analysis for the genes in each of the three significantly pheromone-sensitive transcriptional modules. The gene universe was defined as all genes for which we found an ortholog in all four species (i.e. the set that was used to discover these co-expressed modules). All KEGG terms shown in green were significantly enriched (p < 0.05), and those shown in purple remained significant after correction for multiple testing. Fold enrichment was calculated as the proportion of genes associated with the focal KEGG term in the module, divided by the equivalent proportion in the gene universe.

GO BP

fig_S6 <- module_GO_table %>% 
  filter(Test_type == "GO: Biological process", Module %in% c("Module 1", "Module 4", "Module 9")) %>% 
  module_enrichment_plot()  

saveRDS(fig_S6, file = "supplement/fig_S6.rds")
fig_S6

Version Author Date
f260a62 Luke Holman 2019-03-07



Figure S6: Comparable figure to Figure 4, showing the results of GO: Biological process enrichment analysis instead of KEGG pathways.

GO MF

fig_S7 <- module_GO_table %>% 
  filter(Test_type == "GO: Molecular function", Module %in% c("Module 1", "Module 4", "Module 9")) %>% 
  module_enrichment_plot()  

saveRDS(fig_S7, file = "supplement/fig_S7.rds")
fig_S7

Version Author Date
f260a62 Luke Holman 2019-03-07



Figure S7: Comparable figure to Figure 4, showing the results of GO: Molecular function enrichment analysis instead of KEGG pathways.

GO CC

fig_S8 <- module_GO_table %>% 
  filter(Test_type == "GO: Cellular component", Module %in% c("Module 1", "Module 4", "Module 9")) %>% 
  module_enrichment_plot()  

saveRDS(fig_S8, file = "supplement/fig_S8.rds")
fig_S8

Version Author Date
f260a62 Luke Holman 2019-03-07



Figure S8: Comparable figure to Figure 4, showing the results of GO: Cellular component enrichment analysis instead of KEGG pathways. Module 9 is missing because no GO:CC terms were significantly enriched.

Table of all module enrichment results

Table S24: List of every significant enrichment test result for each module, for all four ontologies. The latter two columns specify all the genes associated with the focal GO or KEGG term that are found in the module. The GeneRatio and BgRatio columns give the number of genes annotated with the focal term that are present in the focal module or the gene universe, respecitvely. These values were used to calculate the enrichment column, as the proportion of genes associated with the focal annotation term in the module, divided by the equivalent proportion in the gene universe.

tab_S24 <- module_GO_table %>% select(-sig, -Count) 
saveRDS(tab_S24 %>% 
          select(-geneID, -gene_names, -qvalue, -GeneRatio, -BgRatio) %>%
          mutate(Test_type = str_replace_all(Test_type, " Biological process", "BP"),
                 Test_type = str_replace_all(Test_type, " Molecular function", "MF"),
                 Test_type = str_replace_all(Test_type, " Cellular component", "CC")), file = "supplement/tab_S24.rds")
kable.table(tab_S24)
Module Test_type ID Description GeneRatio BgRatio enrichment pvalue p.adjust qvalue geneID gene_names
Module 1 GO: Cellular component GO:0044428 nuclear part 62/474 97/1126 1.518378 0.0000050 0.0001739 0.0003165 408606 408611 408615 408632 409049 409423 409544 409735 409810 409906 409994 410195 410200 410343 410395 410459 410855 410864 410907 411072 411265 411279 411433 411465 411619 411918 411985 412072 412077 412199 412268 412377 412589 413181 413351 413404 413499 413523 413548 413793 413963 550895 550924 551131 551383 551470 551620 551745 551974 552353 552449 552563 552601 552696 552703 552780 552794 724855 725905 726816 100576104 100578879 PRP3 pre-mRNA processing factor 3 homolog; Sip1/TFIP11 interacting protein; nuclear transcription factor Y subunit gamma; spliceosome-associated protein CWC15 homolog; paired amphipathic helix protein Sin3a; male-specific lethal 1 homolog; ruvB-like 1; transcription initiation factor TFIID subunit 6; anaphase-promoting complex subunit 4; transcription initiation factor TFIID subunit 2; INO80 complex subunit E; COP9 signalosome complex subunit 6; mRNA turnover protein 4 homolog; nuclear pore complex protein Nup93-like; chromobox protein homolog 1-like; cyclin-H; retinoblastoma-binding protein 5 homolog; nuclear pore complex protein Nup50; U4/U6 small nuclear ribonucleoprotein Prp31; cysteine-rich protein 2-binding protein-like; CXXC-type zinc finger protein 1-like; actin-related protein 8; ell-associated factor Eaf; probable cleavage and polyadenylation specificity factor subunit 2; double-strand-break repair protein rad21 homolog; nuclear pore complex protein Nup205; histone-lysine N-methyltransferase SETD1; DNA replication complex GINS protein PSF1-like; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily E member 1; transcriptional adapter 1-like; transcription initiation factor IIA subunit 1; parafibromin; BRCA1-A complex subunit BRE-like; mortality factor 4-like protein 1; integrator complex subunit 7; ribosome biogenesis protein WDR12 homolog; cell division cycle protein 23 homolog; pre-mRNA-processing factor 17; intron-binding protein aquarius; enhancer of polycomb homolog 1; splicing factor 3A subunit 3; general transcription factor IIH subunit 1; cleavage stimulation factor subunit 2; protein max; protein MAK16 homolog A; general transcription factor IIF subunit 2; pre-mRNA-processing-splicing factor 8; integrator complex subunit 10; thioredoxin-like protein 4A; DNA-directed RNA polymerase III subunit RPC4; mediator of RNA polymerase II transcription subunit 6; transcription initiation factor TFIID subunit 7; lys-63-specific deubiquitinase BRCC36-like; histone acetyltransferase KAT8; KAT8 regulatory NSL complex subunit 2; ribonuclease P/MRP protein subunit POP5; mediator of RNA polymerase II transcription subunit 14; BRISC and BRCA1-A complex member 1-like; pre-mRNA-splicing factor 18; ruvB-like 2; INO80 complex subunit B; protein CASC3
Module 1 GO: Molecular function GO:0003676 nucleic acid binding 174/626 319/1400 1.219866 0.0000397 0.0014682 0.0082704 406077 406084 406123 408295 408336 408352 408386 408580 408611 408615 408620 408710 408711 408724 408815 409028 409059 409098 409119 409251 409259 409340 409392 409493 409550 409557 409573 409696 409833 409839 409866 409883 409887 409915 410027 410203 410326 410328 410376 410410 410434 410571 410749 410757 410876 410918 411103 411126 411164 411265 411293 411351 411407 411450 411492 411538 411640 411649 411705 411780 411786 411833 411854 411985 412077 412190 412410 412491 412574 412750 413055 413087 413091 413139 413146 413176 413498 413558 413650 413690 413794 413815 413963 414004 550692 550858 550924 551083 551240 551242 551309 551398 551470 551538 551540 551586 551602 551616 551620 551739 551825 551840 551997 552022 552027 552056 552072 552112 552151 552172 552206 552247 552255 552303 552308 552336 552353 552450 552484 552509 552527 552539 552567 552768 552772 552787 552815 724150 724247 724296 724315 724363 724424 724810 724955 725012 725061 725189 725201 725220 725254 725268 725303 725330 725350 725441 725496 725515 725719 726058 726204 726385 726583 727087 727113 727284 727473 100576131 100576321 100576600 100576768 100576775 100576784 100577033 100577174 100577272 100577491 100578252 100578406 100578529 100578697 100578743 100578879 100578927 homeotic protein antennapedia; ecdysone receptor; pipsqueak; probable serine/threonine-protein kinase DDB_G0282963; exonuclease mut-7 homolog; elongation factor Ts, mitochondrial; eukaryotic translation initiation factor 3 subunit G; eukaryotic translation initiation factor 2D; Sip1/TFIP11 interacting protein; nuclear transcription factor Y subunit gamma; RNA-binding protein 42; KH domain-containing, RNA-binding, signal transduction-associated protein 2-like; zinc finger matrin-type protein 5-like; uncharacterized LOC408724; probable DNA mismatch repair protein Msh6; probable ATP-dependent RNA helicase YTHDC2; rabenosyn-5; histone-lysine N-methyltransferase eggless; REST corepressor 3; BRCA1-associated protein; protein abrupt; UV excision repair protein RAD23 homolog B; ATPase WRNIP1-like; zinc finger protein 569-like; eukaryotic translation initiation factor 3 subunit D; protein maelstrom; zinc finger protein 2 homolog; splicing factor 45; hemK methyltransferase family member 1; regulator of nonsense transcripts 1; eukaryotic initiation factor 4A-III; splicing factor 3A subunit 1; transcription factor Dp-1; RNA-binding protein 26; survival of motor neuron-related-splicing factor 30; POU domain protein CF1A; Krueppel-like factor 10; zinc finger protein 341-like; peptidyl-tRNA hydrolase ICT1, mitochondrial; ATP-dependent DNA helicase PIF1; splicing factor 3B subunit 4; DNA topoisomerase 3-alpha; squamous cell carcinoma antigen recognized by T-cells 3; circadian locomoter output cycles protein kaput; THUMP domain-containing protein 3-like; protein tramtrack, beta isoform; putative 28S ribosomal protein S5, mitochondrial; broad-complex core protein isoforms 1/2/3/4/5; DNA-directed RNA polymerase III subunit RPC3; CXXC-type zinc finger protein 1-like; zinc finger protein 622; elongation factor G, mitochondrial; leucine-rich repeat-containing protein 47-like; probable ATP-dependent RNA helicase DDX43; ATP-dependent RNA helicase DHX36; pre-mRNA-splicing factor RBM22; DNA replication licensing factor Mcm2; alkylated DNA repair protein alkB homolog 8; synaptojanin-1; zinc finger protein 578-like; general transcription factor IIE subunit 1; la protein homolog; heat shock factor protein; histone-lysine N-methyltransferase SETD1; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily E member 1; probable ATP-dependent RNA helicase DDX47; U3 small nucleolar RNA-associated protein 6 homolog; double-stranded RNA-specific editase 1-like; PR domain zinc finger protein 10-like; DNA topoisomerase 1; uncharacterized LOC413055; tRNA (uracil-5-)-methyltransferase homolog A-like; serrate RNA effector molecule homolog; probable phenylalanine–tRNA ligase, mitochondrial; regulator of nonsense transcripts 2; reticulocyte-binding protein 2 homolog a-like; F-box only protein 21-like; photoreceptor-specific nuclear receptor; nuclear RNA export factor 1-like; helicase SKI2W; translin; CCA tRNA nucleotidyltransferase 1, mitochondrial-like; splicing factor 3A subunit 3; eukaryotic translation initiation factor 3 subunit A; TATA-box-binding protein; RNA-binding protein 40; cleavage stimulation factor subunit 2; probable tRNA pseudouridine synthase 2; uncharacterized LOC551240; eukaryotic translation initiation factor 3 subunit E; transcription initiation factor TFIID subunit 1; DNA polymerase delta catalytic subunit; general transcription factor IIF subunit 2; lysine–tRNA ligase; replication factor C subunit 2; programmed cell death protein 5; ras GTPase-activating protein-binding protein 2; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily A-like protein 1; pre-mRNA-processing-splicing factor 8; DNA primase large subunit; nuclear hormone receptor HR96; YTH domain-containing family protein 1; cleavage and polyadenylation specificity factor subunit 1; zinc finger CCCH-type with G patch domain-containing protein-like; heterogeneous nuclear ribonucleoprotein A1, A2/B1 homolog; eukaryotic translation initiation factor 3 subunit L; exosome complex component CSL4; RNA-binding protein 28; dnaJ homolog subfamily C member 1-like; G patch domain-containing protein 1 homolog; putative ATP-dependent RNA helicase me31b; nuclear factor NF-kappa-B p100 subunit; broad-complex; RNA-binding protein cabeza-like; zinc finger CCHC-type and RNA-binding motif-containing protein 1-like; UBX domain-containing protein 1; DNA-directed RNA polymerase III subunit RPC4; DNA repair protein RAD51 homolog A; uncharacterized LOC552484; MKI67 FHA domain-interacting nucleolar phosphoprotein-like; cell division cycle 5-like protein; density-regulated protein homolog; DEAD-box helicase Dbp80; phenylalanine–tRNA ligase alpha subunit; protein-lysine N-methyltransferase N6AMT2; DNA topoisomerase 3-beta-1; high mobility group protein 20A-like; B-cell lymphoma/leukemia 11B; rRNA methyltransferase 3, mitochondrial; DNA mismatch repair protein Mlh1; forkhead box protein D3-like; activator of basal transcription 1-like; sprT-like domain-containing protein Spartan; mucin-5AC; KH domain-containing protein akap-1; zinc finger protein 25-like; uncharacterized LOC725061; protein bric-a-brac 1-like; 39S ribosomal protein L21, mitochondrial; homeobox protein Nkx-6.1-like; endothelial zinc finger protein induced by tumor necrosis factor alpha; S1 RNA-binding domain-containing protein 1; histone H4 transcription factor; DNA polymerase delta small subunit; GATA-binding factor A; probable ATP-dependent RNA helicase DDX49; dimethyladenosine transferase 1, mitochondrial; zinc finger protein 543-like; DNA-directed RNA polymerase I subunit RPA2; FACT complex subunit Ssrp1; hairy/enhancer-of-split related with YRPW motif protein 1; GTPase Era, mitochondrial; DNA polymerase eta; serine/arginine-rich splicing factor 7; probable ATP-dependent RNA helicase spindle-E; transcription factor Sox-10-like; signal recognition particle 19 kDa protein; zinc finger protein 267-like; uncharacterized LOC100576321; zinc finger protein 345-like; nuclear cap-binding protein subunit 3-like; nucleolar MIF4G domain-containing protein 1 homolog; high mobility group B protein 6-like; zinc finger protein 33B; ras-responsive element-binding protein 1-like; uncharacterized LOC100577272; survival motor neuron protein; Ets at 97D ortholog; asparagine-rich zinc finger protein AZF1-like; zinc finger protein 701-like; THUMP domain-containing protein 1 homolog; zinc finger protein 431-like; protein CASC3; transcriptional repressor protein YY1-like
Module 1 GO: Cellular component GO:0043231 intracellular membrane-bounded organelle 178/474 351/1126 1.204683 0.0000556 0.0009725 0.0017696 406077 406084 408352 408493 408511 408548 408606 408611 408615 408632 408711 408808 408837 409049 409098 409119 409224 409331 409340 409423 409544 409586 409735 409765 409810 409887 409906 409994 410027 410195 410200 410203 410217 410298 410343 410387 410390 410395 410410 410459 410757 410855 410856 410864 410907 411044 411072 411265 411279 411304 411327 411351 411433 411465 411603 411619 411640 411654 411799 411833 411854 411865 411918 411985 412016 412072 412077 412199 412268 412278 412350 412377 412409 412506 412589 412710 412796 412984 413055 413078 413181 413271 413340 413351 413404 413490 413499 413523 413548 413558 413650 413666 413688 413793 413878 413940 413963 550716 550895 550924 551090 551131 551240 551383 551398 551427 551470 551620 551642 551692 551745 551781 551811 551825 551843 551961 551974 551997 552052 552167 552247 552253 552312 552353 552440 552449 552450 552484 552495 552522 552533 552563 552601 552696 552703 552763 552780 552794 552815 685996 724152 724205 724315 724559 724665 724855 724955 725012 725023 725061 725144 725220 725254 725515 725565 725719 725854 725905 726007 726058 726137 726204 726239 726617 726731 726816 727263 727284 100576104 100576131 100576600 100576667 100576784 100577491 100578252 100578450 100578879 100579040 homeotic protein antennapedia; ecdysone receptor; elongation factor Ts, mitochondrial; uncharacterized LOC408493; protein preli-like; MICOS complex subunit Mic60; PRP3 pre-mRNA processing factor 3 homolog; Sip1/TFIP11 interacting protein; nuclear transcription factor Y subunit gamma; spliceosome-associated protein CWC15 homolog; zinc finger matrin-type protein 5-like; prosaposin; cytochrome c oxidase subunit 5A, mitochondrial; paired amphipathic helix protein Sin3a; histone-lysine N-methyltransferase eggless; REST corepressor 3; ubiquinone biosynthesis protein COQ7; YEATS domain-containing protein 2; UV excision repair protein RAD23 homolog B; male-specific lethal 1 homolog; ruvB-like 1; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 9; transcription initiation factor TFIID subunit 6; actin-related protein 6; anaphase-promoting complex subunit 4; transcription factor Dp-1; transcription initiation factor TFIID subunit 2; INO80 complex subunit E; survival of motor neuron-related-splicing factor 30; COP9 signalosome complex subunit 6; mRNA turnover protein 4 homolog; POU domain protein CF1A; structural maintenance of chromosomes protein 3; conserved oligomeric Golgi complex subunit 6; nuclear pore complex protein Nup93-like; conserved oligomeric Golgi complex subunit 3; protein suppressor of forked; chromobox protein homolog 1-like; ATP-dependent DNA helicase PIF1; cyclin-H; circadian locomoter output cycles protein kaput; retinoblastoma-binding protein 5 homolog; 28S ribosomal protein S29, mitochondrial; nuclear pore complex protein Nup50; U4/U6 small nuclear ribonucleoprotein Prp31; inhibitor of growth protein 1; cysteine-rich protein 2-binding protein-like; CXXC-type zinc finger protein 1-like; actin-related protein 8; reticulon-4-interacting protein 1, mitochondrial-like; G1/S-specific cyclin-E1; elongation factor G, mitochondrial; ell-associated factor Eaf; probable cleavage and polyadenylation specificity factor subunit 2; digestive organ expansion factor homolog; double-strand-break repair protein rad21 homolog; DNA replication licensing factor Mcm2; probable tRNA N6-adenosine threonylcarbamoyltransferase; N-acetylgalactosaminyltransferase 7; la protein homolog; heat shock factor protein; exportin-2; nuclear pore complex protein Nup205; histone-lysine N-methyltransferase SETD1; transforming growth factor beta regulator 1; DNA replication complex GINS protein PSF1-like; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily E member 1; transcriptional adapter 1-like; transcription initiation factor IIA subunit 1; tuberin; histone deacetylase 3; parafibromin; mitochondrial import inner membrane translocase subunit TIM44; general vesicular transport factor p115; BRCA1-A complex subunit BRE-like; trafficking protein particle complex subunit 3; 3-hydroxyisobutyryl-CoA hydrolase, mitochondrial; 28S ribosomal protein S30, mitochondrial; uncharacterized LOC413055; very-long-chain (3R)-3-hydroxyacyl-CoA dehydratase; mortality factor 4-like protein 1; galactosylgalactosylxylosylprotein 3-beta-glucuronosyltransferase I; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 10, mitochondrial; integrator complex subunit 7; ribosome biogenesis protein WDR12 homolog; clavesin-2-like; cell division cycle protein 23 homolog; pre-mRNA-processing factor 17; intron-binding protein aquarius; photoreceptor-specific nuclear receptor; nuclear RNA export factor 1-like; peroxisome biogenesis factor 1; DNA-directed RNA polymerase III subunit RPC5; enhancer of polycomb homolog 1; glutamyl-tRNA(Gln) amidotransferase subunit A, mitochondrial; importin-9; splicing factor 3A subunit 3; clathrin heavy chain; general transcription factor IIH subunit 1; cleavage stimulation factor subunit 2; conserved oligomeric Golgi complex subunit 8; protein max; uncharacterized LOC551240; protein MAK16 homolog A; DNA polymerase delta catalytic subunit; erlin-1-like; general transcription factor IIF subunit 2; pre-mRNA-processing-splicing factor 8; GPI mannosyltransferase 4; protein FAM50 homolog; integrator complex subunit 10; pre-rRNA-processing protein TSR1 homolog; graves disease carrier protein homolog; nuclear hormone receptor HR96; LETM1 and EF-hand domain-containing protein anon-60Da, mitochondrial; V-type proton ATPase subunit G; thioredoxin-like protein 4A; cleavage and polyadenylation specificity factor subunit 1; zinc finger protein 330 homolog; IWS1-like protein; nuclear factor NF-kappa-B p100 subunit; mitochondrial chaperone BCS1; RAD50-interacting protein 1; DNA-directed RNA polymerase III subunit RPC4; histone chaperone asf1; mediator of RNA polymerase II transcription subunit 6; DNA repair protein RAD51 homolog A; uncharacterized LOC552484; ATP-binding cassette sub-family D member 3; alpha-(1,6)-fucosyltransferase; GDP-Man:Man(3)GlcNAc(2)-PP-Dol alpha-1,2-mannosyltransferase; transcription initiation factor TFIID subunit 7; lys-63-specific deubiquitinase BRCC36-like; histone acetyltransferase KAT8; KAT8 regulatory NSL complex subunit 2; cell division control protein 6 homolog; ribonuclease P/MRP protein subunit POP5; mediator of RNA polymerase II transcription subunit 14; high mobility group protein 20A-like; suppressor of variegation 3-9; uncharacterized LOC724152; protein AF-9; forkhead box protein D3-like; cell cycle checkpoint protein RAD17; protein SET; BRISC and BRCA1-A complex member 1-like; KH domain-containing protein akap-1; zinc finger protein 25-like; mediator of RNA polymerase II transcription subunit 26; uncharacterized LOC725061; uncharacterized LOC725144; homeobox protein Nkx-6.1-like; endothelial zinc finger protein induced by tumor necrosis factor alpha; zinc finger protein 543-like; nitric oxide synthase-interacting protein homolog; DNA-directed RNA polymerase I subunit RPA2; 39S ribosomal protein L37, mitochondrial; pre-mRNA-splicing factor 18; polycomb protein Scm; FACT complex subunit Ssrp1; male-specific lethal 3 homolog; hairy/enhancer-of-split related with YRPW motif protein 1; putative lipoyltransferase 2, mitochondrial; 39S ribosomal protein L48, mitochondrial; probable 28S ribosomal protein S26, mitochondrial; ruvB-like 2; chromobox protein homolog 5; transcription factor Sox-10-like; INO80 complex subunit B; zinc finger protein 267-like; zinc finger protein 345-like; E3 ubiquitin-protein ligase synoviolin A; high mobility group B protein 6-like; survival motor neuron protein; Ets at 97D ortholog; histone-lysine N-methyltransferase SETD2; protein CASC3; chondroitin sulfate synthase 2
Module 1 KEGG KEGG:03440 Homologous recombination 13/497 14/1081 2.019690 0.0003052 0.0125127 0.0305187 409447 410571 412589 551398 552450 552601 552787 552851 724855 725330 725418 725934 726642 DNA repair and recombination protein RAD54-like; DNA topoisomerase 3-alpha; BRCA1-A complex subunit BRE-like; DNA polymerase delta catalytic subunit; DNA repair protein RAD51 homolog A; lys-63-specific deubiquitinase BRCC36-like; DNA topoisomerase 3-beta-1; crossover junction endonuclease EME1; BRISC and BRCA1-A complex member 1-like; DNA polymerase delta small subunit; replication protein A 32 kDa subunit; replication protein A 70 kDa DNA-binding subunit; DNA repair protein RAD50
Module 1 GO: Biological process GO:0043170 macromolecule metabolic process 226/463 414/960 1.131875 0.0003744 0.0228373 0.0298192 406084 406112 408346 408386 408501 408527 408606 408611 408615 408632 408675 408687 408724 408815 408924 408980 409049 409140 409191 409198 409279 409331 409340 409347 409387 409389 409392 409394 409423 409479 409544 409550 409557 409637 409653 409696 409723 409735 409810 409839 409860 409883 409887 409891 409915 410027 410093 410162 410195 410203 410390 410395 410410 410459 410571 410749 410757 410806 410907 410941 410958 411044 411103 411164 411167 411218 411273 411279 411351 411362 411433 411465 411572 411640 411649 411654 411719 411786 411799 411833 411981 411985 412072 412159 412200 412219 412268 412350 412377 412410 412484 412580 412644 412676 412727 412750 412868 412984 413087 413139 413181 413271 413351 413404 413523 413548 413558 413643 413650 413688 413690 413718 413738 413793 413794 413813 413815 413821 413878 413963 414001 414004 550692 550698 550895 550924 551083 551150 551158 551240 551242 551256 551321 551343 551358 551386 551398 551427 551470 551497 551538 551540 551578 551616 551620 551745 551771 551812 551825 551855 551972 551974 552056 552172 552178 552186 552303 552324 552353 552449 552450 552458 552484 552522 552529 552554 552563 552593 552601 552660 552676 552696 552733 552763 552768 552780 552787 724152 724186 724205 724244 724247 724296 724338 724424 724467 724496 724559 724596 724635 724708 724855 724879 725054 725158 725201 725220 725330 725592 725633 725719 725813 725854 725859 725905 725948 726007 726058 726086 726137 726151 726204 726239 726449 726583 726816 727192 100576667 100576866 100577386 100577491 100578201 100578266 100578450 100578852 100578879 ecdysone receptor; period circadian protein; UPF0396 protein CG6066; eukaryotic translation initiation factor 3 subunit G; serine/threonine-protein kinase/endoribonuclease IRE1; pre-mRNA-splicing factor SPF27; PRP3 pre-mRNA processing factor 3 homolog; Sip1/TFIP11 interacting protein; nuclear transcription factor Y subunit gamma; spliceosome-associated protein CWC15 homolog; probable 39S ribosomal protein L24, mitochondrial; putative tRNA (cytidine(32)/guanosine(34)-2’-O)-methyltransferase; uncharacterized LOC408724; probable DNA mismatch repair protein Msh6; peptidoglycan-recognition protein LC; DNA oxidative demethylase ALKBH1; paired amphipathic helix protein Sin3a; transcription elongation factor B polypeptide 1; SUMO-activating enzyme subunit 2; 26S protease regulatory subunit 6A-B; cullin-4A; YEATS domain-containing protein 2; UV excision repair protein RAD23 homolog B; U4/U6.U5 tri-snRNP-associated protein 1; ubiquitin carboxyl-terminal hydrolase; ubiquitin specific protease-like; ATPase WRNIP1-like; NEDD8-activating enzyme E1 catalytic subunit; male-specific lethal 1 homolog; 60S ribosomal protein L6; ruvB-like 1; eukaryotic translation initiation factor 3 subunit D; protein maelstrom; 60S ribosomal protein L23a; tRNA-splicing ligase RtcB homolog; splicing factor 45; 40S ribosomal protein S12, mitochondrial; transcription initiation factor TFIID subunit 6; anaphase-promoting complex subunit 4; regulator of nonsense transcripts 1; GPI ethanolamine phosphate transferase 3; splicing factor 3A subunit 1; transcription factor Dp-1; cell division cycle and apoptosis regulator protein 1; RNA-binding protein 26; survival of motor neuron-related-splicing factor 30; geminin; ataxin-3-like; COP9 signalosome complex subunit 6; POU domain protein CF1A; protein suppressor of forked; chromobox protein homolog 1-like; ATP-dependent DNA helicase PIF1; cyclin-H; DNA topoisomerase 3-alpha; squamous cell carcinoma antigen recognized by T-cells 3; circadian locomoter output cycles protein kaput; histidine–tRNA ligase, cytoplasmic; U4/U6 small nuclear ribonucleoprotein Prp31; protein MTO1 homolog, mitochondrial; ubiquitin-like modifier-activating enzyme 1; inhibitor of growth protein 1; putative 28S ribosomal protein S5, mitochondrial; DNA-directed RNA polymerase III subunit RPC3; cysteine–tRNA ligase, cytoplasmic; WW domain-binding protein 11; uncharacterized protein DDB_G0287625-like; actin-related protein 8; elongation factor G, mitochondrial; ubiquitin carboxyl-terminal hydrolase 8-like; ell-associated factor Eaf; probable cleavage and polyadenylation specificity factor subunit 2; ubiquitin carboxyl-terminal hydrolase 14; DNA replication licensing factor Mcm2; alkylated DNA repair protein alkB homolog 8; probable tRNA N6-adenosine threonylcarbamoyltransferase; probable queuine tRNA-ribosyltransferase; general transcription factor IIE subunit 1; N-acetylgalactosaminyltransferase 7; la protein homolog; probable ubiquitin carboxyl-terminal hydrolase FAF-X; histone-lysine N-methyltransferase SETD1; DNA replication complex GINS protein PSF1-like; pre-mRNA-splicing factor SYF1; threonine–tRNA ligase, cytoplasmic; ubiquitin conjugation factor E4 B; transcription initiation factor IIA subunit 1; histone deacetylase 3; parafibromin; U3 small nucleolar RNA-associated protein 6 homolog; peptidoglycan recognition protein S2; protein arginine N-methyltransferase 3; josephin-2; protein mahjong; cytosolic carboxypeptidase-like protein 5; DNA topoisomerase 1; ubiquitin fusion degradation protein 1 homolog; 28S ribosomal protein S30, mitochondrial; tRNA (uracil-5-)-methyltransferase homolog A-like; probable phenylalanine–tRNA ligase, mitochondrial; mortality factor 4-like protein 1; galactosylgalactosylxylosylprotein 3-beta-glucuronosyltransferase I; integrator complex subunit 7; ribosome biogenesis protein WDR12 homolog; pre-mRNA-processing factor 17; intron-binding protein aquarius; photoreceptor-specific nuclear receptor; N-acetylglucosaminyl-phosphatidylinositol biosynthetic protein; nuclear RNA export factor 1-like; DNA-directed RNA polymerase III subunit RPC5; helicase SKI2W; probable glutamine–tRNA ligase; uncharacterized LOC413738; enhancer of polycomb homolog 1; translin; ubiquitin carboxyl-terminal hydrolase isozyme L5; CCA tRNA nucleotidyltransferase 1, mitochondrial-like; histone deacetylase complex subunit SAP130-A-like; glutamyl-tRNA(Gln) amidotransferase subunit A, mitochondrial; splicing factor 3A subunit 3; mRNA-capping enzyme; eukaryotic translation initiation factor 3 subunit A; TATA-box-binding protein; cyclin-Y; general transcription factor IIH subunit 1; cleavage stimulation factor subunit 2; probable tRNA pseudouridine synthase 2; BRCA2-interacting transcriptional repressor EMSY; 28S ribosomal protein S17, mitochondrial; uncharacterized LOC551240; eukaryotic translation initiation factor 3 subunit E; protein CNPPD1; 39S ribosomal protein L44, mitochondrial; 26S protease regulatory subunit 7; dehydrodolichyl diphosphate syntase complex subunit DHDDS; 26S protease regulatory subunit 10B; DNA polymerase delta catalytic subunit; erlin-1-like; general transcription factor IIF subunit 2; lariat debranching enzyme; lysine–tRNA ligase; replication factor C subunit 2; protein O-mannosyl-transferase 2; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily A-like protein 1; pre-mRNA-processing-splicing factor 8; integrator complex subunit 10; methionine aminopeptidase 2; mitochondrial tRNA-specific 2-thiouridylase 1; nuclear hormone receptor HR96; exosome complex component rrp45-like; alpha-1,3/1,6-mannosyltransferase ALG2; thioredoxin-like protein 4A; eukaryotic translation initiation factor 3 subunit L; G patch domain-containing protein 1 homolog; nicastrin; cell division cycle protein 20 homolog; RNA-binding protein cabeza-like; ubiquitin carboxyl-terminal hydrolase 5; DNA-directed RNA polymerase III subunit RPC4; mediator of RNA polymerase II transcription subunit 6; DNA repair protein RAD51 homolog A; DNA-directed RNA polymerase II subunit RPB3; uncharacterized LOC552484; alpha-(1,6)-fucosyltransferase; U6 snRNA-associated Sm-like protein LSm4; RNA 3’-terminal phosphate cyclase-like; transcription initiation factor TFIID subunit 7; 39S ribosomal protein L19, mitochondrial; lys-63-specific deubiquitinase BRCC36-like; ubiquitin carboxyl-terminal hydrolase 46; 39S ribosomal protein L3, mitochondrial; histone acetyltransferase KAT8; aurora kinase B; cell division control protein 6 homolog; phenylalanine–tRNA ligase alpha subunit; ribonuclease P/MRP protein subunit POP5; DNA topoisomerase 3-beta-1; uncharacterized LOC724152; 60S ribosomal protein L19; protein AF-9; structural maintenance of chromosomes protein 5; rRNA methyltransferase 3, mitochondrial; DNA mismatch repair protein Mlh1; OTU domain-containing protein 5-B; sprT-like domain-containing protein Spartan; iron-sulfur cluster assembly 2 homolog, mitochondrial-like; adenylyltransferase and sulfurtransferase MOCS3; cell cycle checkpoint protein RAD17; transducin beta-like protein 3; tRNA:m(4)X modification enzyme TRM13 homolog; 39S ribosomal protein L23, mitochondrial; BRISC and BRCA1-A complex member 1-like; methionine aminopeptidase 1D, mitochondrial; nuclear envelope phosphatase-regulatory subunit 1; peptidoglycan-recognition protein 1; 39S ribosomal protein L21, mitochondrial; homeobox protein Nkx-6.1-like; DNA polymerase delta small subunit; protein prenyltransferase alpha subunit repeat-containing protein 1; probable DNA-directed RNA polymerases I and III subunit RPAC2; DNA-directed RNA polymerase I subunit RPA2; uncharacterized LOC725813; 39S ribosomal protein L37, mitochondrial; cell division cycle-associated protein 7-like; pre-mRNA-splicing factor 18; H/ACA ribonucleoprotein complex non-core subunit NAF1; polycomb protein Scm; FACT complex subunit Ssrp1; gem-associated protein 8-like; male-specific lethal 3 homolog; probable 39S ribosomal protein L49, mitochondrial; hairy/enhancer-of-split related with YRPW motif protein 1; putative lipoyltransferase 2, mitochondrial; homologous-pairing protein 2 homolog; DNA polymerase eta; ruvB-like 2; structural maintenance of chromosomes protein 6; E3 ubiquitin-protein ligase synoviolin A; probable elongator complex protein 3; ankyrin repeat and LEM domain-containing protein 2; survival motor neuron protein; uncharacterized LOC100578201; probable deoxyhypusine synthase; histone-lysine N-methyltransferase SETD2; ribonucleases P/MRP protein subunit POP1; protein CASC3
Module 1 GO: Cellular component GO:0043229 intracellular organelle 215/474 447/1126 1.142591 0.0005873 0.0057046 0.0118626 406077 406084 408352 408493 408511 408548 408606 408611 408615 408632 408675 408711 408808 408837 408846 409049 409098 409119 409224 409313 409331 409340 409423 409479 409544 409586 409637 409723 409735 409765 409810 409867 409887 409906 409994 410027 410195 410200 410203 410217 410298 410343 410348 410387 410390 410395 410410 410459 410571 410757 410855 410856 410864 410907 410960 411044 411072 411103 411265 411279 411304 411327 411351 411433 411465 411603 411619 411640 411654 411799 411816 411833 411854 411865 411918 411985 412016 412072 412076 412077 412199 412267 412268 412278 412350 412377 412381 412409 412506 412589 412710 412750 412796 412827 412984 413055 413078 413181 413271 413340 413351 413404 413490 413499 413523 413548 413558 413650 413666 413688 413793 413878 413940 413963 550716 550895 550924 551090 551131 551158 551240 551383 551398 551427 551438 551470 551620 551642 551692 551745 551781 551784 551811 551825 551843 551961 551974 551997 552052 552167 552247 552253 552312 552353 552440 552449 552450 552484 552495 552522 552533 552563 552593 552601 552676 552696 552703 552733 552763 552780 552794 552815 685996 724152 724186 724205 724244 724315 724365 724559 724665 724708 724720 724855 724955 725012 725013 725023 725061 725144 725201 725220 725254 725515 725565 725719 725854 725905 726002 726007 726058 726137 726151 726204 726239 726422 726617 726731 726816 727192 727263 727284 100576104 100576131 100576600 100576667 100576784 100577491 100577816 100578040 100578252 100578450 100578704 100578879 100579040 homeotic protein antennapedia; ecdysone receptor; elongation factor Ts, mitochondrial; uncharacterized LOC408493; protein preli-like; MICOS complex subunit Mic60; PRP3 pre-mRNA processing factor 3 homolog; Sip1/TFIP11 interacting protein; nuclear transcription factor Y subunit gamma; spliceosome-associated protein CWC15 homolog; probable 39S ribosomal protein L24, mitochondrial; zinc finger matrin-type protein 5-like; prosaposin; cytochrome c oxidase subunit 5A, mitochondrial; tyrosine-protein phosphatase non-receptor type 14; paired amphipathic helix protein Sin3a; histone-lysine N-methyltransferase eggless; REST corepressor 3; ubiquinone biosynthesis protein COQ7; actin-related protein 2; YEATS domain-containing protein 2; UV excision repair protein RAD23 homolog B; male-specific lethal 1 homolog; 60S ribosomal protein L6; ruvB-like 1; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 9; 60S ribosomal protein L23a; 40S ribosomal protein S12, mitochondrial; transcription initiation factor TFIID subunit 6; actin-related protein 6; anaphase-promoting complex subunit 4; FERM domain-containing protein 8; transcription factor Dp-1; transcription initiation factor TFIID subunit 2; INO80 complex subunit E; survival of motor neuron-related-splicing factor 30; COP9 signalosome complex subunit 6; mRNA turnover protein 4 homolog; POU domain protein CF1A; structural maintenance of chromosomes protein 3; conserved oligomeric Golgi complex subunit 6; nuclear pore complex protein Nup93-like; katanin p80 WD40 repeat-containing subunit B1; conserved oligomeric Golgi complex subunit 3; protein suppressor of forked; chromobox protein homolog 1-like; ATP-dependent DNA helicase PIF1; cyclin-H; DNA topoisomerase 3-alpha; circadian locomoter output cycles protein kaput; retinoblastoma-binding protein 5 homolog; 28S ribosomal protein S29, mitochondrial; nuclear pore complex protein Nup50; U4/U6 small nuclear ribonucleoprotein Prp31; myosin-IB; inhibitor of growth protein 1; cysteine-rich protein 2-binding protein-like; putative 28S ribosomal protein S5, mitochondrial; CXXC-type zinc finger protein 1-like; actin-related protein 8; reticulon-4-interacting protein 1, mitochondrial-like; G1/S-specific cyclin-E1; elongation factor G, mitochondrial; ell-associated factor Eaf; probable cleavage and polyadenylation specificity factor subunit 2; digestive organ expansion factor homolog; double-strand-break repair protein rad21 homolog; DNA replication licensing factor Mcm2; probable tRNA N6-adenosine threonylcarbamoyltransferase; N-acetylgalactosaminyltransferase 7; cytoplasmic dynein 1 light intermediate chain 1; la protein homolog; heat shock factor protein; exportin-2; nuclear pore complex protein Nup205; histone-lysine N-methyltransferase SETD1; transforming growth factor beta regulator 1; DNA replication complex GINS protein PSF1-like; vacuolar protein-sorting-associated protein 36; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily E member 1; transcriptional adapter 1-like; dynactin subunit 2; transcription initiation factor IIA subunit 1; tuberin; histone deacetylase 3; parafibromin; vacuolar protein-sorting-associated protein 25; mitochondrial import inner membrane translocase subunit TIM44; general vesicular transport factor p115; BRCA1-A complex subunit BRE-like; trafficking protein particle complex subunit 3; DNA topoisomerase 1; 3-hydroxyisobutyryl-CoA hydrolase, mitochondrial; Bardet-Biedl syndrome 2 protein homolog; 28S ribosomal protein S30, mitochondrial; uncharacterized LOC413055; very-long-chain (3R)-3-hydroxyacyl-CoA dehydratase; mortality factor 4-like protein 1; galactosylgalactosylxylosylprotein 3-beta-glucuronosyltransferase I; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 10, mitochondrial; integrator complex subunit 7; ribosome biogenesis protein WDR12 homolog; clavesin-2-like; cell division cycle protein 23 homolog; pre-mRNA-processing factor 17; intron-binding protein aquarius; photoreceptor-specific nuclear receptor; nuclear RNA export factor 1-like; peroxisome biogenesis factor 1; DNA-directed RNA polymerase III subunit RPC5; enhancer of polycomb homolog 1; glutamyl-tRNA(Gln) amidotransferase subunit A, mitochondrial; importin-9; splicing factor 3A subunit 3; clathrin heavy chain; general transcription factor IIH subunit 1; cleavage stimulation factor subunit 2; conserved oligomeric Golgi complex subunit 8; protein max; 28S ribosomal protein S17, mitochondrial; uncharacterized LOC551240; protein MAK16 homolog A; DNA polymerase delta catalytic subunit; erlin-1-like; actin-related protein 1; general transcription factor IIF subunit 2; pre-mRNA-processing-splicing factor 8; GPI mannosyltransferase 4; protein FAM50 homolog; integrator complex subunit 10; pre-rRNA-processing protein TSR1 homolog; probable actin-related protein 2/3 complex subunit 2; graves disease carrier protein homolog; nuclear hormone receptor HR96; LETM1 and EF-hand domain-containing protein anon-60Da, mitochondrial; V-type proton ATPase subunit G; thioredoxin-like protein 4A; cleavage and polyadenylation specificity factor subunit 1; zinc finger protein 330 homolog; IWS1-like protein; nuclear factor NF-kappa-B p100 subunit; mitochondrial chaperone BCS1; RAD50-interacting protein 1; DNA-directed RNA polymerase III subunit RPC4; histone chaperone asf1; mediator of RNA polymerase II transcription subunit 6; DNA repair protein RAD51 homolog A; uncharacterized LOC552484; ATP-binding cassette sub-family D member 3; alpha-(1,6)-fucosyltransferase; GDP-Man:Man(3)GlcNAc(2)-PP-Dol alpha-1,2-mannosyltransferase; transcription initiation factor TFIID subunit 7; 39S ribosomal protein L19, mitochondrial; lys-63-specific deubiquitinase BRCC36-like; 39S ribosomal protein L3, mitochondrial; histone acetyltransferase KAT8; KAT8 regulatory NSL complex subunit 2; aurora kinase B; cell division control protein 6 homolog; ribonuclease P/MRP protein subunit POP5; mediator of RNA polymerase II transcription subunit 14; high mobility group protein 20A-like; suppressor of variegation 3-9; uncharacterized LOC724152; 60S ribosomal protein L19; protein AF-9; structural maintenance of chromosomes protein 5; forkhead box protein D3-like; ragulator complex protein LAMTOR4 homolog; cell cycle checkpoint protein RAD17; protein SET; 39S ribosomal protein L23, mitochondrial; vacuolar protein sorting-associated protein 37B; BRISC and BRCA1-A complex member 1-like; KH domain-containing protein akap-1; zinc finger protein 25-like; sister chromatid cohesion protein DCC1; mediator of RNA polymerase II transcription subunit 26; uncharacterized LOC725061; uncharacterized LOC725144; 39S ribosomal protein L21, mitochondrial; homeobox protein Nkx-6.1-like; endothelial zinc finger protein induced by tumor necrosis factor alpha; zinc finger protein 543-like; nitric oxide synthase-interacting protein homolog; DNA-directed RNA polymerase I subunit RPA2; 39S ribosomal protein L37, mitochondrial; pre-mRNA-splicing factor 18; tyrosine-protein kinase hopscotch; polycomb protein Scm; FACT complex subunit Ssrp1; male-specific lethal 3 homolog; probable 39S ribosomal protein L49, mitochondrial; hairy/enhancer-of-split related with YRPW motif protein 1; putative lipoyltransferase 2, mitochondrial; vacuolar protein sorting-associated protein 37A; 39S ribosomal protein L48, mitochondrial; probable 28S ribosomal protein S26, mitochondrial; ruvB-like 2; structural maintenance of chromosomes protein 6; chromobox protein homolog 5; transcription factor Sox-10-like; INO80 complex subunit B; zinc finger protein 267-like; zinc finger protein 345-like; E3 ubiquitin-protein ligase synoviolin A; high mobility group B protein 6-like; survival motor neuron protein; gamma-tubulin complex component 6; rotatin; Ets at 97D ortholog; histone-lysine N-methyltransferase SETD2; tubulin delta chain-like; protein CASC3; chondroitin sulfate synthase 2
Module 1 GO: Cellular component GO:1990234 transferase complex 31/474 47/1126 1.566837 0.0006520 0.0057046 0.0118626 408577 409279 409423 409544 409735 409810 409906 410459 410855 411072 411265 411985 412199 412219 412268 412377 413181 413351 413499 413793 551131 551470 551745 552353 552563 552696 552703 724244 726816 727192 100576667 uncharacterized LOC408577; cullin-4A; male-specific lethal 1 homolog; ruvB-like 1; transcription initiation factor TFIID subunit 6; anaphase-promoting complex subunit 4; transcription initiation factor TFIID subunit 2; cyclin-H; retinoblastoma-binding protein 5 homolog; cysteine-rich protein 2-binding protein-like; CXXC-type zinc finger protein 1-like; histone-lysine N-methyltransferase SETD1; transcriptional adapter 1-like; ubiquitin conjugation factor E4 B; transcription initiation factor IIA subunit 1; parafibromin; mortality factor 4-like protein 1; integrator complex subunit 7; cell division cycle protein 23 homolog; enhancer of polycomb homolog 1; protein max; general transcription factor IIF subunit 2; integrator complex subunit 10; DNA-directed RNA polymerase III subunit RPC4; transcription initiation factor TFIID subunit 7; histone acetyltransferase KAT8; KAT8 regulatory NSL complex subunit 2; structural maintenance of chromosomes protein 5; ruvB-like 2; structural maintenance of chromosomes protein 6; E3 ubiquitin-protein ligase synoviolin A
Module 1 GO: Biological process GO:0006139 nucleobase-containing compound metabolic process 160/463 285/960 1.164033 0.0009101 0.0265200 0.0621362 406084 406112 408346 408363 408441 408474 408501 408527 408606 408611 408615 408632 408687 408815 408980 409049 409331 409340 409347 409392 409544 409586 409653 409696 409735 409839 409883 409887 409891 409915 410027 410076 410093 410203 410390 410395 410410 410459 410571 410749 410757 410806 410907 410941 411164 411167 411218 411279 411433 411465 411640 411649 411654 411719 411786 411833 412069 412072 412159 412200 412268 412350 412377 412410 412467 412750 413087 413139 413181 413340 413351 413404 413523 413548 413558 413688 413690 413718 413793 413794 413815 413821 413878 413963 414001 550673 550692 550885 550895 550924 551083 551093 551150 551240 551321 551398 551470 551497 551538 551540 551616 551620 551721 551745 551812 551825 551835 551855 551974 551986 552172 552303 552353 552449 552450 552458 552484 552529 552554 552563 552601 552696 552755 552763 552768 552780 552787 724205 724244 724247 724296 724424 724496 724559 724596 724635 724855 725220 725268 725330 725633 725719 725859 725905 725948 726007 726058 726086 726137 726204 726449 726583 726816 727192 100576866 100577491 100578201 100578450 100578852 100578879 ecdysone receptor; period circadian protein; UPF0396 protein CG6066; adenylate cyclase 3; adenosine kinase 1; apyrase; serine/threonine-protein kinase/endoribonuclease IRE1; pre-mRNA-splicing factor SPF27; PRP3 pre-mRNA processing factor 3 homolog; Sip1/TFIP11 interacting protein; nuclear transcription factor Y subunit gamma; spliceosome-associated protein CWC15 homolog; putative tRNA (cytidine(32)/guanosine(34)-2’-O)-methyltransferase; probable DNA mismatch repair protein Msh6; DNA oxidative demethylase ALKBH1; paired amphipathic helix protein Sin3a; YEATS domain-containing protein 2; UV excision repair protein RAD23 homolog B; U4/U6.U5 tri-snRNP-associated protein 1; ATPase WRNIP1-like; ruvB-like 1; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 9; tRNA-splicing ligase RtcB homolog; splicing factor 45; transcription initiation factor TFIID subunit 6; regulator of nonsense transcripts 1; splicing factor 3A subunit 1; transcription factor Dp-1; cell division cycle and apoptosis regulator protein 1; RNA-binding protein 26; survival of motor neuron-related-splicing factor 30; probable uridine-cytidine kinase; geminin; POU domain protein CF1A; protein suppressor of forked; chromobox protein homolog 1-like; ATP-dependent DNA helicase PIF1; cyclin-H; DNA topoisomerase 3-alpha; squamous cell carcinoma antigen recognized by T-cells 3; circadian locomoter output cycles protein kaput; histidine–tRNA ligase, cytoplasmic; U4/U6 small nuclear ribonucleoprotein Prp31; protein MTO1 homolog, mitochondrial; DNA-directed RNA polymerase III subunit RPC3; cysteine–tRNA ligase, cytoplasmic; WW domain-binding protein 11; actin-related protein 8; ell-associated factor Eaf; probable cleavage and polyadenylation specificity factor subunit 2; DNA replication licensing factor Mcm2; alkylated DNA repair protein alkB homolog 8; probable tRNA N6-adenosine threonylcarbamoyltransferase; probable queuine tRNA-ribosyltransferase; general transcription factor IIE subunit 1; la protein homolog; UTP–glucose-1-phosphate uridylyltransferase; DNA replication complex GINS protein PSF1-like; pre-mRNA-splicing factor SYF1; threonine–tRNA ligase, cytoplasmic; transcription initiation factor IIA subunit 1; histone deacetylase 3; parafibromin; U3 small nucleolar RNA-associated protein 6 homolog; bifunctional purine biosynthesis protein PURH; DNA topoisomerase 1; tRNA (uracil-5-)-methyltransferase homolog A-like; probable phenylalanine–tRNA ligase, mitochondrial; mortality factor 4-like protein 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 10, mitochondrial; integrator complex subunit 7; ribosome biogenesis protein WDR12 homolog; pre-mRNA-processing factor 17; intron-binding protein aquarius; photoreceptor-specific nuclear receptor; DNA-directed RNA polymerase III subunit RPC5; helicase SKI2W; probable glutamine–tRNA ligase; enhancer of polycomb homolog 1; translin; CCA tRNA nucleotidyltransferase 1, mitochondrial-like; histone deacetylase complex subunit SAP130-A-like; glutamyl-tRNA(Gln) amidotransferase subunit A, mitochondrial; splicing factor 3A subunit 3; mRNA-capping enzyme; inosine-5’-monophosphate dehydrogenase 1b; TATA-box-binding protein; nicotinate phosphoribosyltransferase; general transcription factor IIH subunit 1; cleavage stimulation factor subunit 2; probable tRNA pseudouridine synthase 2; V-type proton ATPase catalytic subunit A; BRCA2-interacting transcriptional repressor EMSY; uncharacterized LOC551240; 39S ribosomal protein L44, mitochondrial; DNA polymerase delta catalytic subunit; general transcription factor IIF subunit 2; lariat debranching enzyme; lysine–tRNA ligase; replication factor C subunit 2; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily A-like protein 1; pre-mRNA-processing-splicing factor 8; V-type proton ATPase subunit B; integrator complex subunit 10; mitochondrial tRNA-specific 2-thiouridylase 1; nuclear hormone receptor HR96; CTP synthase; exosome complex component rrp45-like; thioredoxin-like protein 4A; deoxyribose-phosphate aldolase; G patch domain-containing protein 1 homolog; RNA-binding protein cabeza-like; DNA-directed RNA polymerase III subunit RPC4; mediator of RNA polymerase II transcription subunit 6; DNA repair protein RAD51 homolog A; DNA-directed RNA polymerase II subunit RPB3; uncharacterized LOC552484; U6 snRNA-associated Sm-like protein LSm4; RNA 3’-terminal phosphate cyclase-like; transcription initiation factor TFIID subunit 7; lys-63-specific deubiquitinase BRCC36-like; histone acetyltransferase KAT8; probable GDP-L-fucose synthase; cell division control protein 6 homolog; phenylalanine–tRNA ligase alpha subunit; ribonuclease P/MRP protein subunit POP5; DNA topoisomerase 3-beta-1; protein AF-9; structural maintenance of chromosomes protein 5; rRNA methyltransferase 3, mitochondrial; DNA mismatch repair protein Mlh1; sprT-like domain-containing protein Spartan; adenylyltransferase and sulfurtransferase MOCS3; cell cycle checkpoint protein RAD17; transducin beta-like protein 3; tRNA:m(4)X modification enzyme TRM13 homolog; BRISC and BRCA1-A complex member 1-like; homeobox protein Nkx-6.1-like; S1 RNA-binding domain-containing protein 1; DNA polymerase delta small subunit; probable DNA-directed RNA polymerases I and III subunit RPAC2; DNA-directed RNA polymerase I subunit RPA2; cell division cycle-associated protein 7-like; pre-mRNA-splicing factor 18; H/ACA ribonucleoprotein complex non-core subunit NAF1; polycomb protein Scm; FACT complex subunit Ssrp1; gem-associated protein 8-like; male-specific lethal 3 homolog; hairy/enhancer-of-split related with YRPW motif protein 1; homologous-pairing protein 2 homolog; DNA polymerase eta; ruvB-like 2; structural maintenance of chromosomes protein 6; probable elongator complex protein 3; survival motor neuron protein; uncharacterized LOC100578201; histone-lysine N-methyltransferase SETD2; ribonucleases P/MRP protein subunit POP1; protein CASC3
Module 1 GO: Cellular component GO:0005681 spliceosomal complex 8/474 8/1126 2.375527 0.0009527 0.0066688 0.0143521 408611 408632 413523 413548 413963 551620 551974 725905 Sip1/TFIP11 interacting protein; spliceosome-associated protein CWC15 homolog; pre-mRNA-processing factor 17; intron-binding protein aquarius; splicing factor 3A subunit 3; pre-mRNA-processing-splicing factor 8; thioredoxin-like protein 4A; pre-mRNA-splicing factor 18
Module 1 KEGG KEGG:03460 Fanconi anemia pathway 11/497 12/1081 1.993796 0.0012792 0.0262233 0.0639592 409389 410571 411121 552450 552787 552851 724296 725418 725934 726583 726862 ubiquitin specific protease-like; DNA topoisomerase 3-alpha; WD repeat-containing protein 48; DNA repair protein RAD51 homolog A; DNA topoisomerase 3-beta-1; crossover junction endonuclease EME1; DNA mismatch repair protein Mlh1; replication protein A 32 kDa subunit; replication protein A 70 kDa DNA-binding subunit; DNA polymerase eta; DNA repair protein REV1
Module 1 GO: Biological process GO:0046483 heterocycle metabolic process 164/463 295/960 1.152689 0.0014783 0.0265200 0.0883095 406084 406112 408346 408363 408441 408474 408501 408527 408606 408611 408615 408632 408687 408815 408859 408980 409049 409331 409340 409347 409392 409544 409586 409653 409696 409735 409839 409883 409887 409891 409915 410027 410076 410093 410203 410390 410395 410410 410459 410571 410749 410757 410806 410907 410941 411164 411167 411218 411279 411433 411465 411640 411649 411654 411719 411786 411833 412069 412072 412159 412200 412268 412350 412377 412410 412467 412750 413087 413139 413181 413340 413351 413404 413523 413548 413558 413688 413690 413718 413793 413794 413815 413821 413878 413963 414001 494506 550673 550692 550885 550895 550924 551083 551093 551150 551240 551321 551398 551470 551497 551538 551540 551616 551620 551721 551745 551812 551825 551835 551855 551974 551986 552172 552303 552353 552449 552450 552458 552484 552529 552554 552563 552601 552663 552696 552755 552763 552768 552780 552787 724205 724244 724247 724296 724424 724496 724559 724596 724635 724855 725220 725268 725330 725633 725719 725859 725905 725948 726007 726058 726086 726137 726204 726449 726583 726754 726816 727192 100576866 100577491 100578201 100578450 100578852 100578879 ecdysone receptor; period circadian protein; UPF0396 protein CG6066; adenylate cyclase 3; adenosine kinase 1; apyrase; serine/threonine-protein kinase/endoribonuclease IRE1; pre-mRNA-splicing factor SPF27; PRP3 pre-mRNA processing factor 3 homolog; Sip1/TFIP11 interacting protein; nuclear transcription factor Y subunit gamma; spliceosome-associated protein CWC15 homolog; putative tRNA (cytidine(32)/guanosine(34)-2’-O)-methyltransferase; probable DNA mismatch repair protein Msh6; pyrroline-5-carboxylate reductase 2; DNA oxidative demethylase ALKBH1; paired amphipathic helix protein Sin3a; YEATS domain-containing protein 2; UV excision repair protein RAD23 homolog B; U4/U6.U5 tri-snRNP-associated protein 1; ATPase WRNIP1-like; ruvB-like 1; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 9; tRNA-splicing ligase RtcB homolog; splicing factor 45; transcription initiation factor TFIID subunit 6; regulator of nonsense transcripts 1; splicing factor 3A subunit 1; transcription factor Dp-1; cell division cycle and apoptosis regulator protein 1; RNA-binding protein 26; survival of motor neuron-related-splicing factor 30; probable uridine-cytidine kinase; geminin; POU domain protein CF1A; protein suppressor of forked; chromobox protein homolog 1-like; ATP-dependent DNA helicase PIF1; cyclin-H; DNA topoisomerase 3-alpha; squamous cell carcinoma antigen recognized by T-cells 3; circadian locomoter output cycles protein kaput; histidine–tRNA ligase, cytoplasmic; U4/U6 small nuclear ribonucleoprotein Prp31; protein MTO1 homolog, mitochondrial; DNA-directed RNA polymerase III subunit RPC3; cysteine–tRNA ligase, cytoplasmic; WW domain-binding protein 11; actin-related protein 8; ell-associated factor Eaf; probable cleavage and polyadenylation specificity factor subunit 2; DNA replication licensing factor Mcm2; alkylated DNA repair protein alkB homolog 8; probable tRNA N6-adenosine threonylcarbamoyltransferase; probable queuine tRNA-ribosyltransferase; general transcription factor IIE subunit 1; la protein homolog; UTP–glucose-1-phosphate uridylyltransferase; DNA replication complex GINS protein PSF1-like; pre-mRNA-splicing factor SYF1; threonine–tRNA ligase, cytoplasmic; transcription initiation factor IIA subunit 1; histone deacetylase 3; parafibromin; U3 small nucleolar RNA-associated protein 6 homolog; bifunctional purine biosynthesis protein PURH; DNA topoisomerase 1; tRNA (uracil-5-)-methyltransferase homolog A-like; probable phenylalanine–tRNA ligase, mitochondrial; mortality factor 4-like protein 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 10, mitochondrial; integrator complex subunit 7; ribosome biogenesis protein WDR12 homolog; pre-mRNA-processing factor 17; intron-binding protein aquarius; photoreceptor-specific nuclear receptor; DNA-directed RNA polymerase III subunit RPC5; helicase SKI2W; probable glutamine–tRNA ligase; enhancer of polycomb homolog 1; translin; CCA tRNA nucleotidyltransferase 1, mitochondrial-like; histone deacetylase complex subunit SAP130-A-like; glutamyl-tRNA(Gln) amidotransferase subunit A, mitochondrial; splicing factor 3A subunit 3; mRNA-capping enzyme; heme oxygenase; inosine-5’-monophosphate dehydrogenase 1b; TATA-box-binding protein; nicotinate phosphoribosyltransferase; general transcription factor IIH subunit 1; cleavage stimulation factor subunit 2; probable tRNA pseudouridine synthase 2; V-type proton ATPase catalytic subunit A; BRCA2-interacting transcriptional repressor EMSY; uncharacterized LOC551240; 39S ribosomal protein L44, mitochondrial; DNA polymerase delta catalytic subunit; general transcription factor IIF subunit 2; lariat debranching enzyme; lysine–tRNA ligase; replication factor C subunit 2; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily A-like protein 1; pre-mRNA-processing-splicing factor 8; V-type proton ATPase subunit B; integrator complex subunit 10; mitochondrial tRNA-specific 2-thiouridylase 1; nuclear hormone receptor HR96; CTP synthase; exosome complex component rrp45-like; thioredoxin-like protein 4A; deoxyribose-phosphate aldolase; G patch domain-containing protein 1 homolog; RNA-binding protein cabeza-like; DNA-directed RNA polymerase III subunit RPC4; mediator of RNA polymerase II transcription subunit 6; DNA repair protein RAD51 homolog A; DNA-directed RNA polymerase II subunit RPB3; uncharacterized LOC552484; U6 snRNA-associated Sm-like protein LSm4; RNA 3’-terminal phosphate cyclase-like; transcription initiation factor TFIID subunit 7; lys-63-specific deubiquitinase BRCC36-like; pyridoxal kinase; histone acetyltransferase KAT8; probable GDP-L-fucose synthase; cell division control protein 6 homolog; phenylalanine–tRNA ligase alpha subunit; ribonuclease P/MRP protein subunit POP5; DNA topoisomerase 3-beta-1; protein AF-9; structural maintenance of chromosomes protein 5; rRNA methyltransferase 3, mitochondrial; DNA mismatch repair protein Mlh1; sprT-like domain-containing protein Spartan; adenylyltransferase and sulfurtransferase MOCS3; cell cycle checkpoint protein RAD17; transducin beta-like protein 3; tRNA:m(4)X modification enzyme TRM13 homolog; BRISC and BRCA1-A complex member 1-like; homeobox protein Nkx-6.1-like; S1 RNA-binding domain-containing protein 1; DNA polymerase delta small subunit; probable DNA-directed RNA polymerases I and III subunit RPAC2; DNA-directed RNA polymerase I subunit RPA2; cell division cycle-associated protein 7-like; pre-mRNA-splicing factor 18; H/ACA ribonucleoprotein complex non-core subunit NAF1; polycomb protein Scm; FACT complex subunit Ssrp1; gem-associated protein 8-like; male-specific lethal 3 homolog; hairy/enhancer-of-split related with YRPW motif protein 1; homologous-pairing protein 2 homolog; DNA polymerase eta; kynurenine formamidase; ruvB-like 2; structural maintenance of chromosomes protein 6; probable elongator complex protein 3; survival motor neuron protein; uncharacterized LOC100578201; histone-lysine N-methyltransferase SETD2; ribonucleases P/MRP protein subunit POP1; protein CASC3
Module 1 GO: Biological process GO:1901360 organic cyclic compound metabolic process 166/463 300/960 1.147300 0.0018598 0.0265200 0.0987528 406084 406112 408346 408363 408441 408474 408501 408527 408606 408611 408615 408622 408632 408687 408815 408859 408980 409049 409331 409340 409347 409392 409544 409586 409653 409696 409735 409839 409883 409887 409891 409915 410027 410076 410093 410203 410390 410395 410410 410459 410571 410749 410757 410806 410907 410941 411164 411167 411218 411279 411433 411465 411640 411649 411654 411719 411786 411833 412069 412072 412159 412200 412268 412350 412377 412410 412467 412750 413087 413139 413181 413340 413351 413404 413523 413548 413558 413688 413690 413718 413793 413794 413815 413821 413878 413963 414001 494506 550673 550692 550885 550895 550924 551083 551093 551150 551240 551321 551398 551470 551497 551538 551540 551616 551620 551721 551745 551812 551825 551835 551855 551974 551986 552172 552303 552353 552449 552450 552458 552484 552529 552554 552563 552601 552663 552696 552755 552763 552768 552780 552787 724205 724244 724247 724296 724424 724496 724559 724596 724635 724855 725018 725220 725268 725330 725633 725719 725859 725905 725948 726007 726058 726086 726137 726204 726449 726583 726754 726816 727192 100576866 100577491 100578201 100578450 100578852 100578879 ecdysone receptor; period circadian protein; UPF0396 protein CG6066; adenylate cyclase 3; adenosine kinase 1; apyrase; serine/threonine-protein kinase/endoribonuclease IRE1; pre-mRNA-splicing factor SPF27; PRP3 pre-mRNA processing factor 3 homolog; Sip1/TFIP11 interacting protein; nuclear transcription factor Y subunit gamma; protein henna; spliceosome-associated protein CWC15 homolog; putative tRNA (cytidine(32)/guanosine(34)-2’-O)-methyltransferase; probable DNA mismatch repair protein Msh6; pyrroline-5-carboxylate reductase 2; DNA oxidative demethylase ALKBH1; paired amphipathic helix protein Sin3a; YEATS domain-containing protein 2; UV excision repair protein RAD23 homolog B; U4/U6.U5 tri-snRNP-associated protein 1; ATPase WRNIP1-like; ruvB-like 1; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 9; tRNA-splicing ligase RtcB homolog; splicing factor 45; transcription initiation factor TFIID subunit 6; regulator of nonsense transcripts 1; splicing factor 3A subunit 1; transcription factor Dp-1; cell division cycle and apoptosis regulator protein 1; RNA-binding protein 26; survival of motor neuron-related-splicing factor 30; probable uridine-cytidine kinase; geminin; POU domain protein CF1A; protein suppressor of forked; chromobox protein homolog 1-like; ATP-dependent DNA helicase PIF1; cyclin-H; DNA topoisomerase 3-alpha; squamous cell carcinoma antigen recognized by T-cells 3; circadian locomoter output cycles protein kaput; histidine–tRNA ligase, cytoplasmic; U4/U6 small nuclear ribonucleoprotein Prp31; protein MTO1 homolog, mitochondrial; DNA-directed RNA polymerase III subunit RPC3; cysteine–tRNA ligase, cytoplasmic; WW domain-binding protein 11; actin-related protein 8; ell-associated factor Eaf; probable cleavage and polyadenylation specificity factor subunit 2; DNA replication licensing factor Mcm2; alkylated DNA repair protein alkB homolog 8; probable tRNA N6-adenosine threonylcarbamoyltransferase; probable queuine tRNA-ribosyltransferase; general transcription factor IIE subunit 1; la protein homolog; UTP–glucose-1-phosphate uridylyltransferase; DNA replication complex GINS protein PSF1-like; pre-mRNA-splicing factor SYF1; threonine–tRNA ligase, cytoplasmic; transcription initiation factor IIA subunit 1; histone deacetylase 3; parafibromin; U3 small nucleolar RNA-associated protein 6 homolog; bifunctional purine biosynthesis protein PURH; DNA topoisomerase 1; tRNA (uracil-5-)-methyltransferase homolog A-like; probable phenylalanine–tRNA ligase, mitochondrial; mortality factor 4-like protein 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 10, mitochondrial; integrator complex subunit 7; ribosome biogenesis protein WDR12 homolog; pre-mRNA-processing factor 17; intron-binding protein aquarius; photoreceptor-specific nuclear receptor; DNA-directed RNA polymerase III subunit RPC5; helicase SKI2W; probable glutamine–tRNA ligase; enhancer of polycomb homolog 1; translin; CCA tRNA nucleotidyltransferase 1, mitochondrial-like; histone deacetylase complex subunit SAP130-A-like; glutamyl-tRNA(Gln) amidotransferase subunit A, mitochondrial; splicing factor 3A subunit 3; mRNA-capping enzyme; heme oxygenase; inosine-5’-monophosphate dehydrogenase 1b; TATA-box-binding protein; nicotinate phosphoribosyltransferase; general transcription factor IIH subunit 1; cleavage stimulation factor subunit 2; probable tRNA pseudouridine synthase 2; V-type proton ATPase catalytic subunit A; BRCA2-interacting transcriptional repressor EMSY; uncharacterized LOC551240; 39S ribosomal protein L44, mitochondrial; DNA polymerase delta catalytic subunit; general transcription factor IIF subunit 2; lariat debranching enzyme; lysine–tRNA ligase; replication factor C subunit 2; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily A-like protein 1; pre-mRNA-processing-splicing factor 8; V-type proton ATPase subunit B; integrator complex subunit 10; mitochondrial tRNA-specific 2-thiouridylase 1; nuclear hormone receptor HR96; CTP synthase; exosome complex component rrp45-like; thioredoxin-like protein 4A; deoxyribose-phosphate aldolase; G patch domain-containing protein 1 homolog; RNA-binding protein cabeza-like; DNA-directed RNA polymerase III subunit RPC4; mediator of RNA polymerase II transcription subunit 6; DNA repair protein RAD51 homolog A; DNA-directed RNA polymerase II subunit RPB3; uncharacterized LOC552484; U6 snRNA-associated Sm-like protein LSm4; RNA 3’-terminal phosphate cyclase-like; transcription initiation factor TFIID subunit 7; lys-63-specific deubiquitinase BRCC36-like; pyridoxal kinase; histone acetyltransferase KAT8; probable GDP-L-fucose synthase; cell division control protein 6 homolog; phenylalanine–tRNA ligase alpha subunit; ribonuclease P/MRP protein subunit POP5; DNA topoisomerase 3-beta-1; protein AF-9; structural maintenance of chromosomes protein 5; rRNA methyltransferase 3, mitochondrial; DNA mismatch repair protein Mlh1; sprT-like domain-containing protein Spartan; adenylyltransferase and sulfurtransferase MOCS3; cell cycle checkpoint protein RAD17; transducin beta-like protein 3; tRNA:m(4)X modification enzyme TRM13 homolog; BRISC and BRCA1-A complex member 1-like; phosphomevalonate kinase; homeobox protein Nkx-6.1-like; S1 RNA-binding domain-containing protein 1; DNA polymerase delta small subunit; probable DNA-directed RNA polymerases I and III subunit RPAC2; DNA-directed RNA polymerase I subunit RPA2; cell division cycle-associated protein 7-like; pre-mRNA-splicing factor 18; H/ACA ribonucleoprotein complex non-core subunit NAF1; polycomb protein Scm; FACT complex subunit Ssrp1; gem-associated protein 8-like; male-specific lethal 3 homolog; hairy/enhancer-of-split related with YRPW motif protein 1; homologous-pairing protein 2 homolog; DNA polymerase eta; kynurenine formamidase; ruvB-like 2; structural maintenance of chromosomes protein 6; probable elongator complex protein 3; survival motor neuron protein; uncharacterized LOC100578201; histone-lysine N-methyltransferase SETD2; ribonucleases P/MRP protein subunit POP1; protein CASC3
Module 1 GO: Biological process GO:0006725 cellular aromatic compound metabolic process 164/463 297/960 1.144927 0.0023156 0.0265200 0.1038832 406084 406112 408346 408363 408441 408474 408501 408527 408606 408611 408615 408622 408632 408687 408815 408980 409049 409331 409340 409347 409392 409544 409586 409653 409696 409735 409839 409883 409887 409891 409915 410027 410076 410093 410203 410390 410395 410410 410459 410571 410749 410757 410806 410907 410941 411164 411167 411218 411279 411433 411465 411640 411649 411654 411719 411786 411833 412069 412072 412159 412200 412268 412350 412377 412410 412467 412750 413087 413139 413181 413340 413351 413404 413523 413548 413558 413688 413690 413718 413793 413794 413815 413821 413878 413963 414001 494506 550673 550692 550885 550895 550924 551083 551093 551150 551240 551321 551398 551470 551497 551538 551540 551616 551620 551721 551745 551812 551825 551835 551855 551974 551986 552172 552303 552353 552449 552450 552458 552484 552529 552554 552563 552601 552663 552696 552755 552763 552768 552780 552787 724205 724244 724247 724296 724424 724496 724559 724596 724635 724855 725220 725268 725330 725633 725719 725859 725905 725948 726007 726058 726086 726137 726204 726449 726583 726754 726816 727192 100576866 100577491 100578201 100578450 100578852 100578879 ecdysone receptor; period circadian protein; UPF0396 protein CG6066; adenylate cyclase 3; adenosine kinase 1; apyrase; serine/threonine-protein kinase/endoribonuclease IRE1; pre-mRNA-splicing factor SPF27; PRP3 pre-mRNA processing factor 3 homolog; Sip1/TFIP11 interacting protein; nuclear transcription factor Y subunit gamma; protein henna; spliceosome-associated protein CWC15 homolog; putative tRNA (cytidine(32)/guanosine(34)-2’-O)-methyltransferase; probable DNA mismatch repair protein Msh6; DNA oxidative demethylase ALKBH1; paired amphipathic helix protein Sin3a; YEATS domain-containing protein 2; UV excision repair protein RAD23 homolog B; U4/U6.U5 tri-snRNP-associated protein 1; ATPase WRNIP1-like; ruvB-like 1; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 9; tRNA-splicing ligase RtcB homolog; splicing factor 45; transcription initiation factor TFIID subunit 6; regulator of nonsense transcripts 1; splicing factor 3A subunit 1; transcription factor Dp-1; cell division cycle and apoptosis regulator protein 1; RNA-binding protein 26; survival of motor neuron-related-splicing factor 30; probable uridine-cytidine kinase; geminin; POU domain protein CF1A; protein suppressor of forked; chromobox protein homolog 1-like; ATP-dependent DNA helicase PIF1; cyclin-H; DNA topoisomerase 3-alpha; squamous cell carcinoma antigen recognized by T-cells 3; circadian locomoter output cycles protein kaput; histidine–tRNA ligase, cytoplasmic; U4/U6 small nuclear ribonucleoprotein Prp31; protein MTO1 homolog, mitochondrial; DNA-directed RNA polymerase III subunit RPC3; cysteine–tRNA ligase, cytoplasmic; WW domain-binding protein 11; actin-related protein 8; ell-associated factor Eaf; probable cleavage and polyadenylation specificity factor subunit 2; DNA replication licensing factor Mcm2; alkylated DNA repair protein alkB homolog 8; probable tRNA N6-adenosine threonylcarbamoyltransferase; probable queuine tRNA-ribosyltransferase; general transcription factor IIE subunit 1; la protein homolog; UTP–glucose-1-phosphate uridylyltransferase; DNA replication complex GINS protein PSF1-like; pre-mRNA-splicing factor SYF1; threonine–tRNA ligase, cytoplasmic; transcription initiation factor IIA subunit 1; histone deacetylase 3; parafibromin; U3 small nucleolar RNA-associated protein 6 homolog; bifunctional purine biosynthesis protein PURH; DNA topoisomerase 1; tRNA (uracil-5-)-methyltransferase homolog A-like; probable phenylalanine–tRNA ligase, mitochondrial; mortality factor 4-like protein 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 10, mitochondrial; integrator complex subunit 7; ribosome biogenesis protein WDR12 homolog; pre-mRNA-processing factor 17; intron-binding protein aquarius; photoreceptor-specific nuclear receptor; DNA-directed RNA polymerase III subunit RPC5; helicase SKI2W; probable glutamine–tRNA ligase; enhancer of polycomb homolog 1; translin; CCA tRNA nucleotidyltransferase 1, mitochondrial-like; histone deacetylase complex subunit SAP130-A-like; glutamyl-tRNA(Gln) amidotransferase subunit A, mitochondrial; splicing factor 3A subunit 3; mRNA-capping enzyme; heme oxygenase; inosine-5’-monophosphate dehydrogenase 1b; TATA-box-binding protein; nicotinate phosphoribosyltransferase; general transcription factor IIH subunit 1; cleavage stimulation factor subunit 2; probable tRNA pseudouridine synthase 2; V-type proton ATPase catalytic subunit A; BRCA2-interacting transcriptional repressor EMSY; uncharacterized LOC551240; 39S ribosomal protein L44, mitochondrial; DNA polymerase delta catalytic subunit; general transcription factor IIF subunit 2; lariat debranching enzyme; lysine–tRNA ligase; replication factor C subunit 2; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily A-like protein 1; pre-mRNA-processing-splicing factor 8; V-type proton ATPase subunit B; integrator complex subunit 10; mitochondrial tRNA-specific 2-thiouridylase 1; nuclear hormone receptor HR96; CTP synthase; exosome complex component rrp45-like; thioredoxin-like protein 4A; deoxyribose-phosphate aldolase; G patch domain-containing protein 1 homolog; RNA-binding protein cabeza-like; DNA-directed RNA polymerase III subunit RPC4; mediator of RNA polymerase II transcription subunit 6; DNA repair protein RAD51 homolog A; DNA-directed RNA polymerase II subunit RPB3; uncharacterized LOC552484; U6 snRNA-associated Sm-like protein LSm4; RNA 3’-terminal phosphate cyclase-like; transcription initiation factor TFIID subunit 7; lys-63-specific deubiquitinase BRCC36-like; pyridoxal kinase; histone acetyltransferase KAT8; probable GDP-L-fucose synthase; cell division control protein 6 homolog; phenylalanine–tRNA ligase alpha subunit; ribonuclease P/MRP protein subunit POP5; DNA topoisomerase 3-beta-1; protein AF-9; structural maintenance of chromosomes protein 5; rRNA methyltransferase 3, mitochondrial; DNA mismatch repair protein Mlh1; sprT-like domain-containing protein Spartan; adenylyltransferase and sulfurtransferase MOCS3; cell cycle checkpoint protein RAD17; transducin beta-like protein 3; tRNA:m(4)X modification enzyme TRM13 homolog; BRISC and BRCA1-A complex member 1-like; homeobox protein Nkx-6.1-like; S1 RNA-binding domain-containing protein 1; DNA polymerase delta small subunit; probable DNA-directed RNA polymerases I and III subunit RPAC2; DNA-directed RNA polymerase I subunit RPA2; cell division cycle-associated protein 7-like; pre-mRNA-splicing factor 18; H/ACA ribonucleoprotein complex non-core subunit NAF1; polycomb protein Scm; FACT complex subunit Ssrp1; gem-associated protein 8-like; male-specific lethal 3 homolog; hairy/enhancer-of-split related with YRPW motif protein 1; homologous-pairing protein 2 homolog; DNA polymerase eta; kynurenine formamidase; ruvB-like 2; structural maintenance of chromosomes protein 6; probable elongator complex protein 3; survival motor neuron protein; uncharacterized LOC100578201; histone-lysine N-methyltransferase SETD2; ribonucleases P/MRP protein subunit POP1; protein CASC3
Module 1 GO: Biological process GO:0033554 cellular response to stress 23/463 31/960 1.538354 0.0026085 0.0265200 0.1038832 408815 408980 409340 409544 409696 410410 411279 550895 551427 551616 552450 552601 724152 724244 724296 724424 724559 724855 726058 726583 726816 727192 100576667 probable DNA mismatch repair protein Msh6; DNA oxidative demethylase ALKBH1; UV excision repair protein RAD23 homolog B; ruvB-like 1; splicing factor 45; ATP-dependent DNA helicase PIF1; actin-related protein 8; general transcription factor IIH subunit 1; erlin-1-like; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily A-like protein 1; DNA repair protein RAD51 homolog A; lys-63-specific deubiquitinase BRCC36-like; uncharacterized LOC724152; structural maintenance of chromosomes protein 5; DNA mismatch repair protein Mlh1; sprT-like domain-containing protein Spartan; cell cycle checkpoint protein RAD17; BRISC and BRCA1-A complex member 1-like; FACT complex subunit Ssrp1; DNA polymerase eta; ruvB-like 2; structural maintenance of chromosomes protein 6; E3 ubiquitin-protein ligase synoviolin A
Module 1 GO: Cellular component GO:0043233 organelle lumen 45/474 78/1126 1.370497 0.0029394 0.0146972 0.0236060 408511 409049 409423 409544 409735 409906 409994 410200 410395 410459 410855 410856 411072 411265 411279 411433 411465 411619 411985 412072 412077 412199 412268 412377 413181 413340 413351 413404 413793 550924 551131 551383 551470 551745 552353 552449 552563 552696 552703 552780 552794 726617 726731 726816 100576104 protein preli-like; paired amphipathic helix protein Sin3a; male-specific lethal 1 homolog; ruvB-like 1; transcription initiation factor TFIID subunit 6; transcription initiation factor TFIID subunit 2; INO80 complex subunit E; mRNA turnover protein 4 homolog; chromobox protein homolog 1-like; cyclin-H; retinoblastoma-binding protein 5 homolog; 28S ribosomal protein S29, mitochondrial; cysteine-rich protein 2-binding protein-like; CXXC-type zinc finger protein 1-like; actin-related protein 8; ell-associated factor Eaf; probable cleavage and polyadenylation specificity factor subunit 2; double-strand-break repair protein rad21 homolog; histone-lysine N-methyltransferase SETD1; DNA replication complex GINS protein PSF1-like; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily E member 1; transcriptional adapter 1-like; transcription initiation factor IIA subunit 1; parafibromin; mortality factor 4-like protein 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 10, mitochondrial; integrator complex subunit 7; ribosome biogenesis protein WDR12 homolog; enhancer of polycomb homolog 1; cleavage stimulation factor subunit 2; protein max; protein MAK16 homolog A; general transcription factor IIF subunit 2; integrator complex subunit 10; DNA-directed RNA polymerase III subunit RPC4; mediator of RNA polymerase II transcription subunit 6; transcription initiation factor TFIID subunit 7; histone acetyltransferase KAT8; KAT8 regulatory NSL complex subunit 2; ribonuclease P/MRP protein subunit POP5; mediator of RNA polymerase II transcription subunit 14; 39S ribosomal protein L48, mitochondrial; probable 28S ribosomal protein S26, mitochondrial; ruvB-like 2; INO80 complex subunit B
Module 1 GO: Cellular component GO:0070013 intracellular organelle lumen 45/474 78/1126 1.370497 0.0029394 0.0146972 0.0236060 408511 409049 409423 409544 409735 409906 409994 410200 410395 410459 410855 410856 411072 411265 411279 411433 411465 411619 411985 412072 412077 412199 412268 412377 413181 413340 413351 413404 413793 550924 551131 551383 551470 551745 552353 552449 552563 552696 552703 552780 552794 726617 726731 726816 100576104 protein preli-like; paired amphipathic helix protein Sin3a; male-specific lethal 1 homolog; ruvB-like 1; transcription initiation factor TFIID subunit 6; transcription initiation factor TFIID subunit 2; INO80 complex subunit E; mRNA turnover protein 4 homolog; chromobox protein homolog 1-like; cyclin-H; retinoblastoma-binding protein 5 homolog; 28S ribosomal protein S29, mitochondrial; cysteine-rich protein 2-binding protein-like; CXXC-type zinc finger protein 1-like; actin-related protein 8; ell-associated factor Eaf; probable cleavage and polyadenylation specificity factor subunit 2; double-strand-break repair protein rad21 homolog; histone-lysine N-methyltransferase SETD1; DNA replication complex GINS protein PSF1-like; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily E member 1; transcriptional adapter 1-like; transcription initiation factor IIA subunit 1; parafibromin; mortality factor 4-like protein 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 10, mitochondrial; integrator complex subunit 7; ribosome biogenesis protein WDR12 homolog; enhancer of polycomb homolog 1; cleavage stimulation factor subunit 2; protein max; protein MAK16 homolog A; general transcription factor IIF subunit 2; integrator complex subunit 10; DNA-directed RNA polymerase III subunit RPC4; mediator of RNA polymerase II transcription subunit 6; transcription initiation factor TFIID subunit 7; histone acetyltransferase KAT8; KAT8 regulatory NSL complex subunit 2; ribonuclease P/MRP protein subunit POP5; mediator of RNA polymerase II transcription subunit 14; 39S ribosomal protein L48, mitochondrial; probable 28S ribosomal protein S26, mitochondrial; ruvB-like 2; INO80 complex subunit B
Module 1 KEGG KEGG:03420 Nucleotide excision repair 11/497 13/1081 1.840427 0.0048673 0.0665198 0.1622435 409279 409340 410459 412240 412593 550895 551398 551540 725330 725418 725934 cullin-4A; UV excision repair protein RAD23 homolog B; cyclin-H; DNA repair protein complementing XP-A cells homolog; DNA damage-binding protein 1; general transcription factor IIH subunit 1; DNA polymerase delta catalytic subunit; replication factor C subunit 2; DNA polymerase delta small subunit; replication protein A 32 kDa subunit; replication protein A 70 kDa DNA-binding subunit
Module 1 GO: Biological process GO:0006325 chromatin organization 17/463 22/960 1.602199 0.0049039 0.0427343 0.1662997 409423 409544 409765 409994 411044 411279 411985 412077 412377 412746 413181 552440 552733 724665 726137 726816 100576104 male-specific lethal 1 homolog; ruvB-like 1; actin-related protein 6; INO80 complex subunit E; inhibitor of growth protein 1; actin-related protein 8; histone-lysine N-methyltransferase SETD1; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily E member 1; parafibromin; calcineurin-binding protein cabin-1-like; mortality factor 4-like protein 1; histone chaperone asf1; aurora kinase B; protein SET; male-specific lethal 3 homolog; ruvB-like 2; INO80 complex subunit B
Module 1 GO: Molecular function GO:0101005 ubiquitinyl hydrolase activity 12/626 15/1400 1.789137 0.0057184 0.0729528 0.1369810 409387 409389 410162 411362 411572 411981 412644 413813 552324 552601 552660 724338 ubiquitin carboxyl-terminal hydrolase; ubiquitin specific protease-like; ataxin-3-like; ubiquitin carboxyl-terminal hydrolase 8-like; ubiquitin carboxyl-terminal hydrolase 14; probable ubiquitin carboxyl-terminal hydrolase FAF-X; josephin-2; ubiquitin carboxyl-terminal hydrolase isozyme L5; ubiquitin carboxyl-terminal hydrolase 5; lys-63-specific deubiquitinase BRCC36-like; ubiquitin carboxyl-terminal hydrolase 46; OTU domain-containing protein 5-B
Module 1 GO: Molecular function GO:0019899 enzyme binding 19/626 27/1400 1.573778 0.0059210 0.0729528 0.1369810 409255 409279 409370 411245 411865 412708 412817 413208 413677 413735 413738 413940 550698 551256 551427 551741 724332 100577386 100578506 active breakpoint cluster region-related protein; cullin-4A; brefeldin A-inhibited guanine nucleotide-exchange protein 1; dedicator of cytokinesis protein 7; exportin-2; calcyclin-binding protein; importin-4-like; rab11 family-interacting protein 2; rho guanine nucleotide exchange factor 10; glutamate–cysteine ligase regulatory subunit; uncharacterized LOC413738; importin-9; cyclin-Y; protein CNPPD1; erlin-1-like; rac guanine nucleotide exchange factor JJ; rho guanine nucleotide exchange factor 3-like; ankyrin repeat and LEM domain-containing protein 2; Rho-associated, coiled-coil containing protein kinase 2
Module 1 GO: Molecular function GO:0008276 protein methyltransferase activity 6/626 6/1400 2.236422 0.0078868 0.0729528 0.1369810 409098 409833 411985 552772 685996 100578450 histone-lysine N-methyltransferase eggless; hemK methyltransferase family member 1; histone-lysine N-methyltransferase SETD1; protein-lysine N-methyltransferase N6AMT2; suppressor of variegation 3-9; histone-lysine N-methyltransferase SETD2
Module 1 KEGG KEGG:03040 Spliceosome 29/497 45/1081 1.401699 0.0084708 0.0868256 0.2117698 408527 408606 408632 409347 409647 409696 409866 409883 410027 410434 410907 411218 411538 412064 412159 413523 413548 413963 550656 551331 551620 551974 552027 552198 552444 552527 552529 725905 727087 pre-mRNA-splicing factor SPF27; PRP3 pre-mRNA processing factor 3 homolog; spliceosome-associated protein CWC15 homolog; U4/U6.U5 tri-snRNP-associated protein 1; THO complex subunit 1; splicing factor 45; eukaryotic initiation factor 4A-III; splicing factor 3A subunit 1; survival of motor neuron-related-splicing factor 30; splicing factor 3B subunit 4; U4/U6 small nuclear ribonucleoprotein Prp31; WW domain-binding protein 11; pre-mRNA-splicing factor RBM22; probable U2 small nuclear ribonucleoprotein A’; pre-mRNA-splicing factor SYF1; pre-mRNA-processing factor 17; intron-binding protein aquarius; splicing factor 3A subunit 3; splicing factor U2AF 50 kDa subunit; splicing factor 3B subunit 1; pre-mRNA-processing-splicing factor 8; thioredoxin-like protein 4A; heterogeneous nuclear ribonucleoprotein A1, A2/B1 homolog; pleiotropic regulator 1; polyglutamine-binding protein 1; cell division cycle 5-like protein; U6 snRNA-associated Sm-like protein LSm4; pre-mRNA-splicing factor 18; serine/arginine-rich splicing factor 7
Module 1 GO: Molecular function GO:0005524 ATP binding 105/626 200/1400 1.174121 0.0104471 0.0773082 0.1674913 406092 408501 408512 408533 408708 408815 408866 409028 409125 409178 409191 409198 409276 409296 409313 409392 409394 409408 409447 409498 409544 409577 409653 409756 409839 409866 410076 410190 410217 410273 410289 410410 410575 410806 410958 410960 411003 411068 411080 411167 411279 411450 411492 411582 411640 411758 411858 412190 412200 412446 412608 412610 412741 412747 413052 413126 413139 413152 413252 413493 413666 413690 413718 413759 413878 550694 550968 551093 551343 551386 551438 551470 551538 551540 551608 551616 551659 551721 551773 551835 552206 552253 552450 552469 552495 552554 552567 552733 552763 552768 552806 724193 724296 724440 724496 725018 725441 725720 726002 726742 726816 727113 100577120 100577699 100578506 cGMP-dependent protein kinase foraging; serine/threonine-protein kinase/endoribonuclease IRE1; origin recognition complex subunit 1; mitogen-activated protein kinase kinase kinase 15; ubiquitin-conjugating enzyme E2 S; probable DNA mismatch repair protein Msh6; uncharacterized aarF domain-containing protein kinase 1; probable ATP-dependent RNA helicase YTHDC2; mitogen-activated protein kinase kinase kinase 4; ATP-dependent zinc metalloprotease YME1 homolog; SUMO-activating enzyme subunit 2; 26S protease regulatory subunit 6A-B; phosphatidylinositol 5-phosphate 4-kinase type-2 alpha; T-complex protein 1 subunit gamma; actin-related protein 2; ATPase WRNIP1-like; NEDD8-activating enzyme E1 catalytic subunit; nuclear valosin-containing protein-like; DNA repair and recombination protein RAD54-like; kinase suppressor of Ras 2; ruvB-like 1; 5’-AMP-activated protein kinase catalytic subunit alpha-2; tRNA-splicing ligase RtcB homolog; vacuolar protein sorting-associated protein 4B; regulator of nonsense transcripts 1; eukaryotic initiation factor 4A-III; probable uridine-cytidine kinase; tyrosine-protein kinase Dnt; structural maintenance of chromosomes protein 3; transcription termination factor 2; paraplegin; ATP-dependent DNA helicase PIF1; dual specificity mitogen-activated protein kinase kinase 4; histidine–tRNA ligase, cytoplasmic; ubiquitin-like modifier-activating enzyme 1; myosin-IB; spermatogenesis-associated protein 5; kinesin 4A; serine/threonine-protein kinase greatwall; cysteine–tRNA ligase, cytoplasmic; actin-related protein 8; probable ATP-dependent RNA helicase DDX43; ATP-dependent RNA helicase DHX36; tyrosine-protein kinase Fer; DNA replication licensing factor Mcm2; N-terminal kinase-like protein; ATPase family AAA domain-containing protein 1-B; probable ATP-dependent RNA helicase DDX47; threonine–tRNA ligase, cytoplasmic; SCY1-like protein 2; serine/threonine-protein kinase D3; glutathione synthetase; manganese-transporting ATPase 13A1; receptor interacting protein kinase 5; uncharacterized LOC413052; serine/threonine-protein kinase TAO1; probable phenylalanine–tRNA ligase, mitochondrial; LIM domain kinase 1; ATP-binding cassette sub-family F member 2; inhibitor of nuclear factor kappa-B kinase subunit epsilon; peroxisome biogenesis factor 1; helicase SKI2W; probable glutamine–tRNA ligase; SCY1-like protein 2; glutamyl-tRNA(Gln) amidotransferase subunit A, mitochondrial; T-complex protein 1 subunit eta; heat shock protein 75 kDa, mitochondrial; V-type proton ATPase catalytic subunit A; 26S protease regulatory subunit 7; 26S protease regulatory subunit 10B; actin-related protein 1; general transcription factor IIF subunit 2; lysine–tRNA ligase; replication factor C subunit 2; serine/threonine-protein kinase pelle; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily A-like protein 1; serine/threonine-protein kinase STE20; V-type proton ATPase subunit B; serine/threonine-protein kinase VRK1-like; CTP synthase; putative ATP-dependent RNA helicase me31b; mitochondrial chaperone BCS1; DNA repair protein RAD51 homolog A; cyclin-dependent kinase 20-like; ATP-binding cassette sub-family D member 3; RNA 3’-terminal phosphate cyclase-like; DEAD-box helicase Dbp80; aurora kinase B; cell division control protein 6 homolog; phenylalanine–tRNA ligase alpha subunit; fidgetin-like protein 1; kinesin 8; DNA mismatch repair protein Mlh1; calcium-transporting ATPase type 2C member 1; adenylyltransferase and sulfurtransferase MOCS3; phosphomevalonate kinase; probable ATP-dependent RNA helicase DDX49; muscle, skeletal receptor tyrosine protein kinase-like; tyrosine-protein kinase hopscotch; chromosome transmission fidelity protein 18 homolog; ruvB-like 2; probable ATP-dependent RNA helicase spindle-E; dual specificity protein kinase TTK; 5-formyltetrahydrofolate cyclo-ligase; Rho-associated, coiled-coil containing protein kinase 2
Module 1 GO: Cellular component GO:0005667 transcription factor complex 10/474 13/1126 1.827329 0.0114707 0.0457043 0.0622908 408615 409735 409887 409906 410459 410757 412268 551131 551470 552563 nuclear transcription factor Y subunit gamma; transcription initiation factor TFIID subunit 6; transcription factor Dp-1; transcription initiation factor TFIID subunit 2; cyclin-H; circadian locomoter output cycles protein kaput; transcription initiation factor IIA subunit 1; protein max; general transcription factor IIF subunit 2; transcription initiation factor TFIID subunit 7
Module 1 GO: Biological process GO:0022402 cell cycle process 12/463 15/960 1.658747 0.0119068 0.0907896 0.2860218 409810 411194 413499 552450 552733 724244 724819 725013 725144 726449 100577120 100577386 anaphase-promoting complex subunit 4; MAU2 chromatid cohesion factor homolog; cell division cycle protein 23 homolog; DNA repair protein RAD51 homolog A; aurora kinase B; structural maintenance of chromosomes protein 5; mitotic spindle assembly checkpoint protein MAD1; sister chromatid cohesion protein DCC1; uncharacterized LOC725144; homologous-pairing protein 2 homolog; dual specificity protein kinase TTK; ankyrin repeat and LEM domain-containing protein 2
Module 1 GO: Cellular component GO:0033202 DNA helicase complex 5/474 5/1126 2.375527 0.0130578 0.0457043 0.0622908 409544 409994 411279 726816 100576104 ruvB-like 1; INO80 complex subunit E; actin-related protein 8; ruvB-like 2; INO80 complex subunit B
Module 1 GO: Cellular component GO:0044446 intracellular organelle part 110/474 225/1126 1.161369 0.0130584 0.0457043 0.0622908 408511 408548 408606 408611 408615 408632 408837 409049 409224 409313 409423 409544 409586 409723 409735 409810 409906 409994 410195 410200 410298 410343 410348 410387 410395 410459 410855 410856 410864 410907 410960 411072 411265 411279 411433 411465 411619 411799 411816 411918 411985 412072 412076 412077 412199 412267 412268 412377 412381 412409 412506 412589 413078 413181 413271 413340 413351 413404 413490 413499 413523 413548 413666 413793 413963 550716 550895 550924 551090 551131 551383 551438 551470 551620 551642 551745 551784 551811 551961 551974 552353 552449 552522 552533 552563 552601 552696 552703 552733 552780 552794 724186 724244 724365 724720 724855 725013 725905 726422 726617 726731 726816 727192 100576104 100576667 100577816 100578040 100578704 100578879 100579040 protein preli-like; MICOS complex subunit Mic60; PRP3 pre-mRNA processing factor 3 homolog; Sip1/TFIP11 interacting protein; nuclear transcription factor Y subunit gamma; spliceosome-associated protein CWC15 homolog; cytochrome c oxidase subunit 5A, mitochondrial; paired amphipathic helix protein Sin3a; ubiquinone biosynthesis protein COQ7; actin-related protein 2; male-specific lethal 1 homolog; ruvB-like 1; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 9; 40S ribosomal protein S12, mitochondrial; transcription initiation factor TFIID subunit 6; anaphase-promoting complex subunit 4; transcription initiation factor TFIID subunit 2; INO80 complex subunit E; COP9 signalosome complex subunit 6; mRNA turnover protein 4 homolog; conserved oligomeric Golgi complex subunit 6; nuclear pore complex protein Nup93-like; katanin p80 WD40 repeat-containing subunit B1; conserved oligomeric Golgi complex subunit 3; chromobox protein homolog 1-like; cyclin-H; retinoblastoma-binding protein 5 homolog; 28S ribosomal protein S29, mitochondrial; nuclear pore complex protein Nup50; U4/U6 small nuclear ribonucleoprotein Prp31; myosin-IB; cysteine-rich protein 2-binding protein-like; CXXC-type zinc finger protein 1-like; actin-related protein 8; ell-associated factor Eaf; probable cleavage and polyadenylation specificity factor subunit 2; double-strand-break repair protein rad21 homolog; N-acetylgalactosaminyltransferase 7; cytoplasmic dynein 1 light intermediate chain 1; nuclear pore complex protein Nup205; histone-lysine N-methyltransferase SETD1; DNA replication complex GINS protein PSF1-like; vacuolar protein-sorting-associated protein 36; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily E member 1; transcriptional adapter 1-like; dynactin subunit 2; transcription initiation factor IIA subunit 1; parafibromin; vacuolar protein-sorting-associated protein 25; mitochondrial import inner membrane translocase subunit TIM44; general vesicular transport factor p115; BRCA1-A complex subunit BRE-like; very-long-chain (3R)-3-hydroxyacyl-CoA dehydratase; mortality factor 4-like protein 1; galactosylgalactosylxylosylprotein 3-beta-glucuronosyltransferase I; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 10, mitochondrial; integrator complex subunit 7; ribosome biogenesis protein WDR12 homolog; clavesin-2-like; cell division cycle protein 23 homolog; pre-mRNA-processing factor 17; intron-binding protein aquarius; peroxisome biogenesis factor 1; enhancer of polycomb homolog 1; splicing factor 3A subunit 3; clathrin heavy chain; general transcription factor IIH subunit 1; cleavage stimulation factor subunit 2; conserved oligomeric Golgi complex subunit 8; protein max; protein MAK16 homolog A; actin-related protein 1; general transcription factor IIF subunit 2; pre-mRNA-processing-splicing factor 8; GPI mannosyltransferase 4; integrator complex subunit 10; probable actin-related protein 2/3 complex subunit 2; graves disease carrier protein homolog; V-type proton ATPase subunit G; thioredoxin-like protein 4A; DNA-directed RNA polymerase III subunit RPC4; mediator of RNA polymerase II transcription subunit 6; alpha-(1,6)-fucosyltransferase; GDP-Man:Man(3)GlcNAc(2)-PP-Dol alpha-1,2-mannosyltransferase; transcription initiation factor TFIID subunit 7; lys-63-specific deubiquitinase BRCC36-like; histone acetyltransferase KAT8; KAT8 regulatory NSL complex subunit 2; aurora kinase B; ribonuclease P/MRP protein subunit POP5; mediator of RNA polymerase II transcription subunit 14; 60S ribosomal protein L19; structural maintenance of chromosomes protein 5; ragulator complex protein LAMTOR4 homolog; vacuolar protein sorting-associated protein 37B; BRISC and BRCA1-A complex member 1-like; sister chromatid cohesion protein DCC1; pre-mRNA-splicing factor 18; vacuolar protein sorting-associated protein 37A; 39S ribosomal protein L48, mitochondrial; probable 28S ribosomal protein S26, mitochondrial; ruvB-like 2; structural maintenance of chromosomes protein 6; INO80 complex subunit B; E3 ubiquitin-protein ligase synoviolin A; gamma-tubulin complex component 6; rotatin; tubulin delta chain-like; protein CASC3; chondroitin sulfate synthase 2
Module 1 KEGG KEGG:03430 Mismatch repair 7/497 8/1081 1.903169 0.0203963 0.1672496 0.4079260 408815 551398 551540 724296 725330 725418 725934 probable DNA mismatch repair protein Msh6; DNA polymerase delta catalytic subunit; replication factor C subunit 2; DNA mismatch repair protein Mlh1; DNA polymerase delta small subunit; replication protein A 32 kDa subunit; replication protein A 70 kDa DNA-binding subunit
Module 1 GO: Molecular function GO:0060589 nucleoside-triphosphatase regulator activity 11/626 15/1400 1.640043 0.0235601 0.1452871 0.2134963 409230 409255 411909 412130 412278 550748 551546 724383 726432 727108 727370 arf-GAP with coiled-coil, ANK repeat and PH domain-containing protein 2; active breakpoint cluster region-related protein; ran GTPase-activating protein 1; ral GTPase-activating protein subunit beta; tuberin; stromal membrane-associated protein 1; BAG family molecular chaperone regulator 2; centaurin-gamma-1A; rab GTPase-binding effector protein 1; rho GTPase-activating protein 26; uncharacterized LOC727370
Module 1 GO: Molecular function GO:0005543 phospholipid binding 12/626 17/1400 1.578651 0.0277456 0.1466554 0.2266136 408945 409154 410052 410297 411145 412076 413129 413460 413490 413831 414028 727370 sorting nexin-27; sorting nexin-30-like; synaptotagmin 20; sorting nexin-16; nischarin; vacuolar protein-sorting-associated protein 36; sorting nexin-29; sorting nexin-13-like; clavesin-2-like; sorting nexin lst-4; sorting nexin-4-like; uncharacterized LOC727370
Module 1 GO: Cellular component GO:0044427 chromosomal part 13/474 20/1126 1.544093 0.0318258 0.1012640 0.1307615 409049 409544 409994 410395 411279 412072 412077 413181 724244 725013 726816 727192 100576104 paired amphipathic helix protein Sin3a; ruvB-like 1; INO80 complex subunit E; chromobox protein homolog 1-like; actin-related protein 8; DNA replication complex GINS protein PSF1-like; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily E member 1; mortality factor 4-like protein 1; structural maintenance of chromosomes protein 5; sister chromatid cohesion protein DCC1; ruvB-like 2; structural maintenance of chromosomes protein 6; INO80 complex subunit B
Module 1 GO: Molecular function GO:0016772 transferase activity, transferring phosphorus-containing groups 56/626 104/1400 1.204227 0.0328882 0.1521079 0.2373289 406092 408441 408501 408533 408866 409125 409199 409255 409276 409498 409577 409860 410076 410190 410575 411080 411164 411582 411698 411758 411974 412069 412446 412608 412747 413052 413126 413152 413493 413688 413759 413815 413879 414001 551041 551240 551398 551500 551608 551659 551739 551773 552353 552458 552469 552663 552733 724496 725018 725330 725719 725720 726002 727071 100577120 100578506 cGMP-dependent protein kinase foraging; adenosine kinase 1; serine/threonine-protein kinase/endoribonuclease IRE1; mitogen-activated protein kinase kinase kinase 15; uncharacterized aarF domain-containing protein kinase 1; mitogen-activated protein kinase kinase kinase 4; glycerol kinase; active breakpoint cluster region-related protein; phosphatidylinositol 5-phosphate 4-kinase type-2 alpha; kinase suppressor of Ras 2; 5’-AMP-activated protein kinase catalytic subunit alpha-2; GPI ethanolamine phosphate transferase 3; probable uridine-cytidine kinase; tyrosine-protein kinase Dnt; dual specificity mitogen-activated protein kinase kinase 4; serine/threonine-protein kinase greatwall; DNA-directed RNA polymerase III subunit RPC3; tyrosine-protein kinase Fer; ethanolaminephosphotransferase 1-like; N-terminal kinase-like protein; translation initiation factor eIF-2B subunit gamma; UTP–glucose-1-phosphate uridylyltransferase; SCY1-like protein 2; serine/threonine-protein kinase D3; receptor interacting protein kinase 5; uncharacterized LOC413052; serine/threonine-protein kinase TAO1; LIM domain kinase 1; inhibitor of nuclear factor kappa-B kinase subunit epsilon; DNA-directed RNA polymerase III subunit RPC5; SCY1-like protein 2; CCA tRNA nucleotidyltransferase 1, mitochondrial-like; CDP-diacylglycerol–glycerol-3-phosphate 3-phosphatidyltransferase, mitochondrial; mRNA-capping enzyme; glycerol kinase; uncharacterized LOC551240; DNA polymerase delta catalytic subunit; phosphatidylinositol 4,5-bisphosphate 3-kinase catalytic subunit delta isoform; serine/threonine-protein kinase pelle; serine/threonine-protein kinase STE20; DNA primase large subunit; serine/threonine-protein kinase VRK1-like; DNA-directed RNA polymerase III subunit RPC4; DNA-directed RNA polymerase II subunit RPB3; cyclin-dependent kinase 20-like; pyridoxal kinase; aurora kinase B; adenylyltransferase and sulfurtransferase MOCS3; phosphomevalonate kinase; DNA polymerase delta small subunit; DNA-directed RNA polymerase I subunit RPA2; muscle, skeletal receptor tyrosine protein kinase-like; tyrosine-protein kinase hopscotch; acylglycerol kinase, mitochondrial; dual specificity protein kinase TTK; Rho-associated, coiled-coil containing protein kinase 2
Module 1 GO: Biological process GO:0006996 organelle organization 48/463 82/960 1.213718 0.0329815 0.2079691 0.5618279 409313 409423 409544 409755 409765 409810 409994 410200 410217 410348 410410 410571 411044 411194 411279 411472 411985 412077 412377 412409 412506 412746 412750 412827 413181 413196 413490 413499 413666 551784 552026 552253 552288 552440 552714 552733 552787 724244 724665 724819 725013 726137 726449 726816 100576104 100577386 100577816 100578040 actin-related protein 2; male-specific lethal 1 homolog; ruvB-like 1; beta-parvin; actin-related protein 6; anaphase-promoting complex subunit 4; INO80 complex subunit E; mRNA turnover protein 4 homolog; structural maintenance of chromosomes protein 3; katanin p80 WD40 repeat-containing subunit B1; ATP-dependent DNA helicase PIF1; DNA topoisomerase 3-alpha; inhibitor of growth protein 1; MAU2 chromatid cohesion factor homolog; actin-related protein 8; dynamin-1-like protein; histone-lysine N-methyltransferase SETD1; SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily E member 1; parafibromin; mitochondrial import inner membrane translocase subunit TIM44; general vesicular transport factor p115; calcineurin-binding protein cabin-1-like; DNA topoisomerase 1; Bardet-Biedl syndrome 2 protein homolog; mortality factor 4-like protein 1; ribosome maturation protein SBDS; clavesin-2-like; cell division cycle protein 23 homolog; peroxisome biogenesis factor 1; probable actin-related protein 2/3 complex subunit 2; F-actin-uncapping protein LRRC16A; mitochondrial chaperone BCS1; golgin-45; histone chaperone asf1; conserved oligomeric Golgi complex subunit 2; aurora kinase B; DNA topoisomerase 3-beta-1; structural maintenance of chromosomes protein 5; protein SET; mitotic spindle assembly checkpoint protein MAD1; sister chromatid cohesion protein DCC1; male-specific lethal 3 homolog; homologous-pairing protein 2 homolog; ruvB-like 2; INO80 complex subunit B; ankyrin repeat and LEM domain-containing protein 2; gamma-tubulin complex component 6; rotatin
Module 1 GO: Biological process GO:0000278 mitotic cell cycle 10/463 13/960 1.594949 0.0340933 0.2079691 0.5618279 409810 409887 411194 413499 552450 552733 724819 725013 100577120 100577386 anaphase-promoting complex subunit 4; transcription factor Dp-1; MAU2 chromatid cohesion factor homolog; cell division cycle protein 23 homolog; DNA repair protein RAD51 homolog A; aurora kinase B; mitotic spindle assembly checkpoint protein MAD1; sister chromatid cohesion protein DCC1; dual specificity protein kinase TTK; ankyrin repeat and LEM domain-containing protein 2
Module 1 GO: Cellular component GO:0044798 nuclear transcription factor complex 8/474 11/1126 1.727656 0.0396861 0.1157513 0.1579613 408615 409735 409906 410459 412268 551131 551470 552563 nuclear transcription factor Y subunit gamma; transcription initiation factor TFIID subunit 6; transcription initiation factor TFIID subunit 2; cyclin-H; transcription initiation factor IIA subunit 1; protein max; general transcription factor IIF subunit 2; transcription initiation factor TFIID subunit 7
Module 1 GO: Molecular function GO:0016810 hydrolase activity, acting on carbon-nitrogen (but not peptide) bonds 10/626 14/1400 1.597444 0.0399149 0.1640946 0.2595882 408924 408969 409532 412350 412467 412484 413631 413878 725158 726754 peptidoglycan-recognition protein LC; aminoacylase-1-like; NAD-dependent protein deacetylase Sirt2; histone deacetylase 3; bifunctional purine biosynthesis protein PURH; peptidoglycan recognition protein S2; vanin-like protein 1; glutamyl-tRNA(Gln) amidotransferase subunit A, mitochondrial; peptidoglycan-recognition protein 1; kynurenine formamidase
Module 1 GO: Biological process GO:1903047 mitotic cell cycle process 8/463 10/960 1.658747 0.0424858 0.2356032 0.6344923 409810 411194 413499 552450 724819 725013 100577120 100577386 anaphase-promoting complex subunit 4; MAU2 chromatid cohesion factor homolog; cell division cycle protein 23 homolog; DNA repair protein RAD51 homolog A; mitotic spindle assembly checkpoint protein MAD1; sister chromatid cohesion protein DCC1; dual specificity protein kinase TTK; ankyrin repeat and LEM domain-containing protein 2
Module 1 GO: Molecular function GO:0008047 enzyme activator activity 11/626 16/1400 1.537540 0.0453823 0.1679144 0.2627395 409230 409255 411909 412130 412278 550748 724383 725550 726432 727108 727370 arf-GAP with coiled-coil, ANK repeat and PH domain-containing protein 2; active breakpoint cluster region-related protein; ran GTPase-activating protein 1; ral GTPase-activating protein subunit beta; tuberin; stromal membrane-associated protein 1; centaurin-gamma-1A; proteasome activator complex subunit 4A-like; rab GTPase-binding effector protein 1; rho GTPase-activating protein 26; uncharacterized LOC727370
Module 1 GO: Cellular component GO:0030880 RNA polymerase complex 10/474 15/1126 1.583685 0.0475700 0.1275787 0.1666615 409735 409906 410459 412268 412377 413351 551470 551745 552353 552563 transcription initiation factor TFIID subunit 6; transcription initiation factor TFIID subunit 2; cyclin-H; transcription initiation factor IIA subunit 1; parafibromin; integrator complex subunit 7; general transcription factor IIF subunit 2; integrator complex subunit 10; DNA-directed RNA polymerase III subunit RPC4; transcription initiation factor TFIID subunit 7
Module 1 KEGG KEGG:00310 Lysine degradation 10/497 14/1081 1.553607 0.0487202 0.3329215 0.8120037 409098 410254 411070 411140 411985 552130 725458 726218 100578450 100578909 histone-lysine N-methyltransferase eggless; glutaryl-CoA dehydrogenase, mitochondrial; histone-lysine N-methyltransferase, H3 lysine-79 specific; putative aldehyde dehydrogenase family 7 member A1 homolog; histone-lysine N-methyltransferase SETD1; alpha-aminoadipic semialdehyde synthase, mitochondrial; hydroxylysine kinase; acetyl-CoA acetyltransferase, mitochondrial; histone-lysine N-methyltransferase SETD2; procollagen-lysine,2-oxoglutarate 5-dioxygenase 3
Module 2 KEGG KEGG:03010 Ribosome 41/221 55/1081 3.646318 0.0000000 0.0000000 0.0000000 406120 406126 408526 408799 409294 409326 409552 410188 411380 413137 413296 413875 550651 550711 551107 551125 551330 551418 551644 551867 551870 552097 552106 552241 552266 552272 552318 552445 552517 552564 552632 552774 724142 724233 724868 725647 725884 726013 726439 726789 727128 ribosomal protein LP1; ribosomal protein S8; 60S ribosomal protein L4; 40S ribosomal protein S24; 60S ribosomal protein L23; 40S ribosomal protein S2; 40S ribosomal protein S10-like; 60S ribosomal protein L8; 60S ribosomal protein L30; 60S ribosomal protein L15; 40S ribosomal protein S3a; 60S ribosomal protein L31; 40S ribosomal protein S4; 60S acidic ribosomal protein P0; 60S ribosomal protein L9; 40S ribosomal protein S15Aa; 40S ribosomal protein S3; 60S ribosomal protein L13a; 40S ribosomal protein S15; 40S ribosomal protein S13; 60S ribosomal protein L36; 39S ribosomal protein L14, mitochondrial; uncharacterized LOC552106; 60S ribosomal protein L5; 40S ribosomal protein S12; 40S ribosomal protein S23; 60S ribosomal protein L27a; 60S ribosomal protein L3; 60S ribosomal protein L13; 40S ribosomal protein S7; 60S ribosomal protein L22; 60S ribosomal protein L28; 60S ribosomal protein L24; 40S ribosomal protein S17; 40S ribosomal protein S11; 40S ribosomal protein S6; 60S acidic ribosomal protein P2; 40S ribosomal protein S20; 40S ribosomal protein S16; 40S ribosomal protein S26; 60S ribosomal protein L34
Module 2 GO: Cellular component GO:0005840 ribosome 39/210 57/1126 3.668672 0.0000000 0.0000000 0.0000000 406120 406126 408526 408799 409294 409326 410024 410188 411380 413137 413296 413875 413884 550651 550711 551107 551125 551330 551418 551644 551867 551870 552097 552106 552241 552272 552318 552517 552564 552632 552774 724233 724868 725647 725884 726013 726439 726789 727128 ribosomal protein LP1; ribosomal protein S8; 60S ribosomal protein L4; 40S ribosomal protein S24; 60S ribosomal protein L23; 40S ribosomal protein S2; 40S ribosomal protein S19-like; 60S ribosomal protein L8; 60S ribosomal protein L30; 60S ribosomal protein L15; 40S ribosomal protein S3a; 60S ribosomal protein L31; ubiquitin-40S ribosomal protein S27a; 40S ribosomal protein S4; 60S acidic ribosomal protein P0; 60S ribosomal protein L9; 40S ribosomal protein S15Aa; 40S ribosomal protein S3; 60S ribosomal protein L13a; 40S ribosomal protein S15; 40S ribosomal protein S13; 60S ribosomal protein L36; 39S ribosomal protein L14, mitochondrial; uncharacterized LOC552106; 60S ribosomal protein L5; 40S ribosomal protein S23; 60S ribosomal protein L27a; 60S ribosomal protein L13; 40S ribosomal protein S7; 60S ribosomal protein L22; 60S ribosomal protein L28; 40S ribosomal protein S17; 40S ribosomal protein S11; 40S ribosomal protein S6; 60S acidic ribosomal protein P2; 40S ribosomal protein S20; 40S ribosomal protein S16; 40S ribosomal protein S26; 60S ribosomal protein L34
Module 2 GO: Cellular component GO:0005737 cytoplasm 95/210 309/1126 1.648482 0.0000000 0.0000000 0.0000000 406120 406126 406152 408284 408353 408418 408424 408526 408650 408782 408799 408901 408986 408987 409023 409079 409258 409294 409326 409397 409802 409809 409825 409842 409978 410024 410026 410030 410092 410188 410627 411147 411380 411520 411765 411778 412083 412289 412308 412511 412554 412842 412913 412975 413137 413145 413296 413762 413875 413884 413889 544670 550651 550667 550711 551107 551125 551275 551330 551418 551644 551841 551867 551870 551960 552001 552097 552106 552118 552241 552272 552318 552517 552531 552564 552632 552774 552776 724233 724516 724868 725057 725105 725583 725647 725789 725884 726013 726205 726301 726439 726789 727128 100577081 100578006 ribosomal protein LP1; ribosomal protein S8; juvenile hormone epoxide hydrolase 1; mitochondrial import receptor subunit TOM40 homolog 1-like; proteasome subunit beta type-7; AP-2 complex subunit mu; COP9 signalosome complex subunit 8; 60S ribosomal protein L4; inositol oxygenase; tubulin beta-1; 40S ribosomal protein S24; actin-related protein 2/3 complex subunit 1A; proteasome subunit alpha type-3; sortilin-related receptor; methylthioribose-1-phosphate isomerase; eukaryotic translation initiation factor 4E type 3-A-like; eukaryotic translation initiation factor 3 subunit I; 60S ribosomal protein L23; 40S ribosomal protein S2; signal peptidase complex catalytic subunit SEC11A; proteasome subunit alpha type-2; T-complex protein 1 subunit beta; T-complex protein 1 subunit epsilon; eukaryotic translation initiation factor 3 subunit M; proteasome subunit beta type-2-like; 40S ribosomal protein S19-like; 26S proteasome regulatory complex subunit p48A; protein SEC13 homolog; dual oxidase maturation factor 1; 60S ribosomal protein L8; putative aminopeptidase W07G4.4; AP-2 complex subunit alpha; 60S ribosomal protein L30; proteasome subunit beta type-4; rab GDP dissociation inhibitor beta; RNA-binding protein 8A; coatomer subunit gamma; cytosolic Fe-S cluster assembly factor NUBP1 homolog; flap endonuclease 1; importin subunit alpha-3; transmembrane emp24 domain-containing protein eca; sorting nexin-8-like; Golgi SNAP receptor complex member 2; E3 ubiquitin-protein ligase parkin; 60S ribosomal protein L15; eukaryotic translation initiation factor 3 subunit F; 40S ribosomal protein S3a; complement component 1 Q subcomponent-binding protein, mitochondrial; 60S ribosomal protein L31; ubiquitin-40S ribosomal protein S27a; cytoplasmic tRNA 2-thiolation protein 1; elongation factor 1-alpha F2; 40S ribosomal protein S4; succinate dehydrogenase [ubiquinone] flavoprotein subunit, mitochondrial; 60S acidic ribosomal protein P0; 60S ribosomal protein L9; 40S ribosomal protein S15Aa; T-complex protein 1 subunit delta; 40S ribosomal protein S3; 60S ribosomal protein L13a; 40S ribosomal protein S15; probable dolichyl pyrophosphate Glc1Man9GlcNAc2 alpha-1,3-glucosyltransferase; 40S ribosomal protein S13; 60S ribosomal protein L36; eukaryotic translation initiation factor 3 subunit K; UDP-galactose translocator; 39S ribosomal protein L14, mitochondrial; uncharacterized LOC552106; pyrimidodiazepine synthase; 60S ribosomal protein L5; 40S ribosomal protein S23; 60S ribosomal protein L27a; 60S ribosomal protein L13; 10 kDa heat shock protein, mitochondrial; 40S ribosomal protein S7; 60S ribosomal protein L22; 60S ribosomal protein L28; signal recognition particle subunit SRP68; 40S ribosomal protein S17; 39S ribosomal protein L50, mitochondrial-like; 40S ribosomal protein S11; coatomer subunit beta; UDP-sugar transporter UST74c-like; bridging integrator 3-like; 40S ribosomal protein S6; ragulator complex protein LAMTOR1; 60S acidic ribosomal protein P2; 40S ribosomal protein S20; inosine triphosphate pyrophosphatase; actin-related protein 2/3 complex subunit 4; 40S ribosomal protein S16; 40S ribosomal protein S26; 60S ribosomal protein L34; dihydroorotate dehydrogenase (quinone), mitochondrial; inorganic pyrophosphatase
Module 2 GO: Biological process GO:0019538 protein metabolic process 68/199 188/960 1.744895 0.0000000 0.0000011 0.0000015 406120 406126 408293 408353 408424 408526 408799 408986 409234 409258 409294 409326 409397 409560 409770 409802 409842 409978 410024 410026 410188 410385 410664 410763 411090 411380 411458 411520 411695 412557 413137 413145 413213 413296 413875 413884 413889 550651 550901 551029 551107 551125 551330 551418 551644 551841 551867 551870 551960 552097 552106 552241 552272 552318 552517 552564 552632 552774 724233 724868 725647 725789 725884 726013 726439 726782 726789 727128 ribosomal protein LP1; ribosomal protein S8; exostosin-1; proteasome subunit beta type-7; COP9 signalosome complex subunit 8; 60S ribosomal protein L4; 40S ribosomal protein S24; proteasome subunit alpha type-3; S-phase kinase-associated protein 1; eukaryotic translation initiation factor 3 subunit I; 60S ribosomal protein L23; 40S ribosomal protein S2; signal peptidase complex catalytic subunit SEC11A; eukaryotic translation initiation factor 4B; probable tubulin polyglutamylase TTLL1; proteasome subunit alpha type-2; eukaryotic translation initiation factor 3 subunit M; proteasome subunit beta type-2-like; 40S ribosomal protein S19-like; 26S proteasome regulatory complex subunit p48A; 60S ribosomal protein L8; methionine aminopeptidase 1; protein arginine N-methyltransferase 5; deoxyhypusine hydroxylase; tubulin–tyrosine ligase-like protein 12; 60S ribosomal protein L30; histone-arginine methyltransferase CARMER; proteasome subunit beta type-4; proteasome subunit beta type-1; diphthine methyl ester synthase; 60S ribosomal protein L15; eukaryotic translation initiation factor 3 subunit F; tubulin polyglutamylase TTLL4-like; 40S ribosomal protein S3a; 60S ribosomal protein L31; ubiquitin-40S ribosomal protein S27a; cytoplasmic tRNA 2-thiolation protein 1; 40S ribosomal protein S4; protein phosphatase methylesterase 1; inhibitor of growth protein 5; 60S ribosomal protein L9; 40S ribosomal protein S15Aa; 40S ribosomal protein S3; 60S ribosomal protein L13a; 40S ribosomal protein S15; probable dolichyl pyrophosphate Glc1Man9GlcNAc2 alpha-1,3-glucosyltransferase; 40S ribosomal protein S13; 60S ribosomal protein L36; eukaryotic translation initiation factor 3 subunit K; 39S ribosomal protein L14, mitochondrial; uncharacterized LOC552106; 60S ribosomal protein L5; 40S ribosomal protein S23; 60S ribosomal protein L27a; 60S ribosomal protein L13; 40S ribosomal protein S7; 60S ribosomal protein L22; 60S ribosomal protein L28; 40S ribosomal protein S17; 40S ribosomal protein S11; 40S ribosomal protein S6; ragulator complex protein LAMTOR1; 60S acidic ribosomal protein P2; 40S ribosomal protein S20; 40S ribosomal protein S16; PEST proteolytic signal-containing nuclear protein-like; 40S ribosomal protein S26; 60S ribosomal protein L34
Module 2 GO: Cellular component GO:0043232 intracellular non-membrane-bounded organelle 48/210 125/1126 2.058971 0.0000000 0.0000003 0.0000006 406120 406126 408526 408585 408782 408799 408901 409294 409326 410024 410188 411380 412308 413137 413296 413686 413875 413884 550651 550711 551107 551125 551330 551418 551644 551867 551870 552097 552106 552241 552272 552318 552517 552564 552582 552632 552774 724233 724432 724868 725647 725884 726013 726301 726439 726789 727128 727247 ribosomal protein LP1; ribosomal protein S8; 60S ribosomal protein L4; dynactin subunit 6; tubulin beta-1; 40S ribosomal protein S24; actin-related protein 2/3 complex subunit 1A; 60S ribosomal protein L23; 40S ribosomal protein S2; 40S ribosomal protein S19-like; 60S ribosomal protein L8; 60S ribosomal protein L30; flap endonuclease 1; 60S ribosomal protein L15; 40S ribosomal protein S3a; H/ACA ribonucleoprotein complex subunit 1; 60S ribosomal protein L31; ubiquitin-40S ribosomal protein S27a; 40S ribosomal protein S4; 60S acidic ribosomal protein P0; 60S ribosomal protein L9; 40S ribosomal protein S15Aa; 40S ribosomal protein S3; 60S ribosomal protein L13a; 40S ribosomal protein S15; 40S ribosomal protein S13; 60S ribosomal protein L36; 39S ribosomal protein L14, mitochondrial; uncharacterized LOC552106; 60S ribosomal protein L5; 40S ribosomal protein S23; 60S ribosomal protein L27a; 60S ribosomal protein L13; 40S ribosomal protein S7; brahma-associated protein of 60 kDa; 60S ribosomal protein L22; 60S ribosomal protein L28; 40S ribosomal protein S17; ribosomal RNA processing protein 36 homolog; 40S ribosomal protein S11; 40S ribosomal protein S6; 60S acidic ribosomal protein P2; 40S ribosomal protein S20; actin-related protein 2/3 complex subunit 4; 40S ribosomal protein S16; 40S ribosomal protein S26; 60S ribosomal protein L34; non-structural maintenance of chromosomes element 1 homolog
Module 2 GO: Cellular component GO:0044444 cytoplasmic part 67/210 214/1126 1.678727 0.0000004 0.0000033 0.0000071 406120 406126 406152 408284 408418 408526 408799 408987 409258 409294 409326 409397 409842 410024 410030 410092 410188 411147 411380 412083 412308 412554 412842 412913 412975 413137 413145 413296 413762 413875 413884 550651 550667 550711 551107 551125 551330 551418 551644 551841 551867 551870 551960 552001 552097 552106 552241 552272 552318 552517 552564 552632 552774 552776 724233 724516 724868 725057 725105 725647 725789 725884 726013 726439 726789 727128 100577081 ribosomal protein LP1; ribosomal protein S8; juvenile hormone epoxide hydrolase 1; mitochondrial import receptor subunit TOM40 homolog 1-like; AP-2 complex subunit mu; 60S ribosomal protein L4; 40S ribosomal protein S24; sortilin-related receptor; eukaryotic translation initiation factor 3 subunit I; 60S ribosomal protein L23; 40S ribosomal protein S2; signal peptidase complex catalytic subunit SEC11A; eukaryotic translation initiation factor 3 subunit M; 40S ribosomal protein S19-like; protein SEC13 homolog; dual oxidase maturation factor 1; 60S ribosomal protein L8; AP-2 complex subunit alpha; 60S ribosomal protein L30; coatomer subunit gamma; flap endonuclease 1; transmembrane emp24 domain-containing protein eca; sorting nexin-8-like; Golgi SNAP receptor complex member 2; E3 ubiquitin-protein ligase parkin; 60S ribosomal protein L15; eukaryotic translation initiation factor 3 subunit F; 40S ribosomal protein S3a; complement component 1 Q subcomponent-binding protein, mitochondrial; 60S ribosomal protein L31; ubiquitin-40S ribosomal protein S27a; 40S ribosomal protein S4; succinate dehydrogenase [ubiquinone] flavoprotein subunit, mitochondrial; 60S acidic ribosomal protein P0; 60S ribosomal protein L9; 40S ribosomal protein S15Aa; 40S ribosomal protein S3; 60S ribosomal protein L13a; 40S ribosomal protein S15; probable dolichyl pyrophosphate Glc1Man9GlcNAc2 alpha-1,3-glucosyltransferase; 40S ribosomal protein S13; 60S ribosomal protein L36; eukaryotic translation initiation factor 3 subunit K; UDP-galactose translocator; 39S ribosomal protein L14, mitochondrial; uncharacterized LOC552106; 60S ribosomal protein L5; 40S ribosomal protein S23; 60S ribosomal protein L27a; 60S ribosomal protein L13; 40S ribosomal protein S7; 60S ribosomal protein L22; 60S ribosomal protein L28; signal recognition particle subunit SRP68; 40S ribosomal protein S17; 39S ribosomal protein L50, mitochondrial-like; 40S ribosomal protein S11; coatomer subunit beta; UDP-sugar transporter UST74c-like; 40S ribosomal protein S6; ragulator complex protein LAMTOR1; 60S acidic ribosomal protein P2; 40S ribosomal protein S20; 40S ribosomal protein S16; 40S ribosomal protein S26; 60S ribosomal protein L34; dihydroorotate dehydrogenase (quinone), mitochondrial
Module 2 GO: Biological process GO:1901564 organonitrogen compound metabolic process 84/199 271/960 1.495299 0.0000012 0.0000287 0.0000589 406120 406126 408293 408353 408368 408424 408526 408799 408986 409023 409234 409258 409294 409326 409397 409487 409560 409770 409802 409842 409978 410024 410026 410122 410188 410385 410664 410763 411090 411307 411380 411458 411520 411695 412015 412557 413137 413145 413213 413296 413481 413854 413875 413884 413889 550651 550767 550901 551029 551107 551125 551330 551418 551644 551785 551841 551867 551870 551948 551960 551966 551983 552097 552106 552241 552272 552318 552517 552556 552564 552632 552774 724233 724868 725647 725789 725884 726013 726439 726782 726789 727128 727293 100577081 ribosomal protein LP1; ribosomal protein S8; exostosin-1; proteasome subunit beta type-7; adenosylhomocysteinase; COP9 signalosome complex subunit 8; 60S ribosomal protein L4; 40S ribosomal protein S24; proteasome subunit alpha type-3; methylthioribose-1-phosphate isomerase; S-phase kinase-associated protein 1; eukaryotic translation initiation factor 3 subunit I; 60S ribosomal protein L23; 40S ribosomal protein S2; signal peptidase complex catalytic subunit SEC11A; probable glutamine-dependent NAD(+) synthetase; eukaryotic translation initiation factor 4B; probable tubulin polyglutamylase TTLL1; proteasome subunit alpha type-2; eukaryotic translation initiation factor 3 subunit M; proteasome subunit beta type-2-like; 40S ribosomal protein S19-like; 26S proteasome regulatory complex subunit p48A; glyceraldehyde-3-phosphate dehydrogenase 2; 60S ribosomal protein L8; methionine aminopeptidase 1; protein arginine N-methyltransferase 5; deoxyhypusine hydroxylase; tubulin–tyrosine ligase-like protein 12; mitochondrial enolase superfamily member 1-like; 60S ribosomal protein L30; histone-arginine methyltransferase CARMER; proteasome subunit beta type-4; proteasome subunit beta type-1; 6-pyruvoyl tetrahydrobiopterin synthase; diphthine methyl ester synthase; 60S ribosomal protein L15; eukaryotic translation initiation factor 3 subunit F; tubulin polyglutamylase TTLL4-like; 40S ribosomal protein S3a; probable chitinase 3; xylosyltransferase oxt; 60S ribosomal protein L31; ubiquitin-40S ribosomal protein S27a; cytoplasmic tRNA 2-thiolation protein 1; 40S ribosomal protein S4; ribose 5-phosphate isomerase A; protein phosphatase methylesterase 1; inhibitor of growth protein 5; 60S ribosomal protein L9; 40S ribosomal protein S15Aa; 40S ribosomal protein S3; 60S ribosomal protein L13a; 40S ribosomal protein S15; 6-phosphogluconolactonase; probable dolichyl pyrophosphate Glc1Man9GlcNAc2 alpha-1,3-glucosyltransferase; 40S ribosomal protein S13; 60S ribosomal protein L36; uracil phosphoribosyltransferase homolog; eukaryotic translation initiation factor 3 subunit K; multifunctional protein ADE2; thymidylate synthase; 39S ribosomal protein L14, mitochondrial; uncharacterized LOC552106; 60S ribosomal protein L5; 40S ribosomal protein S23; 60S ribosomal protein L27a; 60S ribosomal protein L13; arginase-1; 40S ribosomal protein S7; 60S ribosomal protein L22; 60S ribosomal protein L28; 40S ribosomal protein S17; 40S ribosomal protein S11; 40S ribosomal protein S6; ragulator complex protein LAMTOR1; 60S acidic ribosomal protein P2; 40S ribosomal protein S20; 40S ribosomal protein S16; PEST proteolytic signal-containing nuclear protein-like; 40S ribosomal protein S26; 60S ribosomal protein L34; guanine deaminase; dihydroorotate dehydrogenase (quinone), mitochondrial
Module 2 GO: Cellular component GO:0044391 ribosomal subunit 9/210 14/1126 3.446939 0.0001965 0.0013363 0.0027409 409326 410188 413296 551330 551418 551644 552272 552318 726013 40S ribosomal protein S2; 60S ribosomal protein L8; 40S ribosomal protein S3a; 40S ribosomal protein S3; 60S ribosomal protein L13a; 40S ribosomal protein S15; 40S ribosomal protein S23; 60S ribosomal protein L27a; 40S ribosomal protein S20
Module 2 GO: Biological process GO:0044260 cellular macromolecule metabolic process 86/199 314/960 1.321256 0.0003197 0.0049016 0.0113287 406120 406126 408293 408353 408424 408526 408728 408799 408986 409234 409258 409294 409326 409397 409472 409560 409770 409802 409822 409842 409978 409979 410024 410174 410188 410385 410494 410664 410753 410763 411090 411380 411458 411520 411695 412308 412388 412557 413137 413145 413213 413296 413520 413875 413884 413889 550651 550901 551029 551107 551125 551212 551330 551418 551644 551734 551841 551867 551870 551960 552097 552106 552241 552272 552318 552517 552564 552599 552632 552774 724233 724412 724868 725352 725647 725789 725884 726013 726184 726359 726439 726782 726789 727128 727247 100578801 ribosomal protein LP1; ribosomal protein S8; exostosin-1; proteasome subunit beta type-7; COP9 signalosome complex subunit 8; 60S ribosomal protein L4; mediator of RNA polymerase II transcription subunit 18; 40S ribosomal protein S24; proteasome subunit alpha type-3; S-phase kinase-associated protein 1; eukaryotic translation initiation factor 3 subunit I; 60S ribosomal protein L23; 40S ribosomal protein S2; signal peptidase complex catalytic subunit SEC11A; protein Smaug homolog 1; eukaryotic translation initiation factor 4B; probable tubulin polyglutamylase TTLL1; proteasome subunit alpha type-2; enhancer of split m7 protein-like; eukaryotic translation initiation factor 3 subunit M; proteasome subunit beta type-2-like; DNA replication licensing factor Mcm7; 40S ribosomal protein S19-like; cyclin-T; 60S ribosomal protein L8; methionine aminopeptidase 1; DNA-directed RNA polymerases I, II, and III subunit RPABC2; protein arginine N-methyltransferase 5; TATA-box-binding protein-like; deoxyhypusine hydroxylase; tubulin–tyrosine ligase-like protein 12; 60S ribosomal protein L30; histone-arginine methyltransferase CARMER; proteasome subunit beta type-4; proteasome subunit beta type-1; flap endonuclease 1; cell differentiation protein RCD1 homolog; diphthine methyl ester synthase; 60S ribosomal protein L15; eukaryotic translation initiation factor 3 subunit F; tubulin polyglutamylase TTLL4-like; 40S ribosomal protein S3a; mediator of RNA polymerase II transcription subunit 4; 60S ribosomal protein L31; ubiquitin-40S ribosomal protein S27a; cytoplasmic tRNA 2-thiolation protein 1; 40S ribosomal protein S4; protein phosphatase methylesterase 1; inhibitor of growth protein 5; 60S ribosomal protein L9; 40S ribosomal protein S15Aa; mediator of RNA polymerase II transcription subunit 16; 40S ribosomal protein S3; 60S ribosomal protein L13a; 40S ribosomal protein S15; DNA excision repair protein haywire; probable dolichyl pyrophosphate Glc1Man9GlcNAc2 alpha-1,3-glucosyltransferase; 40S ribosomal protein S13; 60S ribosomal protein L36; eukaryotic translation initiation factor 3 subunit K; 39S ribosomal protein L14, mitochondrial; uncharacterized LOC552106; 60S ribosomal protein L5; 40S ribosomal protein S23; 60S ribosomal protein L27a; 60S ribosomal protein L13; 40S ribosomal protein S7; DNA-directed RNA polymerase II subunit RPB7; 60S ribosomal protein L22; 60S ribosomal protein L28; 40S ribosomal protein S17; muscle segmentation homeobox; 40S ribosomal protein S11; U6 snRNA-associated Sm-like protein LSm7; 40S ribosomal protein S6; ragulator complex protein LAMTOR1; 60S acidic ribosomal protein P2; 40S ribosomal protein S20; uncharacterized LOC726184; protein SMG8; 40S ribosomal protein S16; PEST proteolytic signal-containing nuclear protein-like; 40S ribosomal protein S26; 60S ribosomal protein L34; non-structural maintenance of chromosomes element 1 homolog; uncharacterized LOC100578801
Module 2 GO: Cellular component GO:0005839 proteasome core complex 6/210 9/1126 3.574603 0.0020066 0.0113707 0.0223894 408353 408986 409802 409978 411520 411695 proteasome subunit beta type-7; proteasome subunit alpha type-3; proteasome subunit alpha type-2; proteasome subunit beta type-2-like; proteasome subunit beta type-4; proteasome subunit beta type-1
Module 2 GO: Cellular component GO:1905368 peptidase complex 8/210 17/1126 2.523249 0.0066764 0.0324282 0.0677223 408353 408702 408986 409397 409802 409978 411520 411695 proteasome subunit beta type-7; SAGA-associated factor 29; proteasome subunit alpha type-3; signal peptidase complex catalytic subunit SEC11A; proteasome subunit alpha type-2; proteasome subunit beta type-2-like; proteasome subunit beta type-4; proteasome subunit beta type-1
Module 2 KEGG KEGG:00590 Arachidonic acid metabolism 4/221 5/1081 3.913122 0.0071690 0.1173348 0.2530455 409614 494523 551072 552304 group XIIA secretory phospholipase A2; glutathione peroxidase-like 1; carbonyl reductase [NADPH] 1-like; glutathione S-transferase S1
Module 2 GO: Cellular component GO:0000502 proteasome complex 6/210 11/1126 2.924675 0.0078927 0.0335440 0.0677431 408353 408986 409802 409978 411520 411695 proteasome subunit beta type-7; proteasome subunit alpha type-3; proteasome subunit alpha type-2; proteasome subunit beta type-2-like; proteasome subunit beta type-4; proteasome subunit beta type-1
Module 2 KEGG KEGG:03050 Proteasome 11/221 26/1081 2.069440 0.0085855 0.1173348 0.2530455 408353 408397 408986 409802 409978 410026 410072 411520 411695 551411 552319 proteasome subunit beta type-7; 26S proteasome non-ATPase regulatory subunit 11; proteasome subunit alpha type-3; proteasome subunit alpha type-2; proteasome subunit beta type-2-like; 26S proteasome regulatory complex subunit p48A; 26S proteasome non-ATPase regulatory subunit 14; proteasome subunit beta type-4; proteasome subunit beta type-1; proteasome maturation protein; 26S proteasome non-ATPase regulatory subunit 6
Module 2 GO: Biological process GO:1901576 organic substance biosynthetic process 73/199 286/960 1.231332 0.0114452 0.1111003 0.2445490 406120 406126 408293 408526 408728 408799 409023 409258 409294 409326 409472 409487 409560 409822 409842 409979 410024 410122 410174 410188 410494 410753 411380 412015 412308 412557 413137 413145 413296 413520 413655 413854 413875 413884 550651 551107 551125 551212 551330 551418 551644 551734 551841 551867 551870 551960 551966 551983 552097 552106 552241 552272 552318 552517 552556 552564 552599 552632 552774 724233 724412 724868 725105 725647 725884 726013 726184 726205 726439 726789 727128 100577081 100578801 ribosomal protein LP1; ribosomal protein S8; exostosin-1; 60S ribosomal protein L4; mediator of RNA polymerase II transcription subunit 18; 40S ribosomal protein S24; methylthioribose-1-phosphate isomerase; eukaryotic translation initiation factor 3 subunit I; 60S ribosomal protein L23; 40S ribosomal protein S2; protein Smaug homolog 1; probable glutamine-dependent NAD(+) synthetase; eukaryotic translation initiation factor 4B; enhancer of split m7 protein-like; eukaryotic translation initiation factor 3 subunit M; DNA replication licensing factor Mcm7; 40S ribosomal protein S19-like; glyceraldehyde-3-phosphate dehydrogenase 2; cyclin-T; 60S ribosomal protein L8; DNA-directed RNA polymerases I, II, and III subunit RPABC2; TATA-box-binding protein-like; 60S ribosomal protein L30; 6-pyruvoyl tetrahydrobiopterin synthase; flap endonuclease 1; diphthine methyl ester synthase; 60S ribosomal protein L15; eukaryotic translation initiation factor 3 subunit F; 40S ribosomal protein S3a; mediator of RNA polymerase II transcription subunit 4; 3-oxoacyl-[acyl-carrier-protein] synthase, mitochondrial; xylosyltransferase oxt; 60S ribosomal protein L31; ubiquitin-40S ribosomal protein S27a; 40S ribosomal protein S4; 60S ribosomal protein L9; 40S ribosomal protein S15Aa; mediator of RNA polymerase II transcription subunit 16; 40S ribosomal protein S3; 60S ribosomal protein L13a; 40S ribosomal protein S15; DNA excision repair protein haywire; probable dolichyl pyrophosphate Glc1Man9GlcNAc2 alpha-1,3-glucosyltransferase; 40S ribosomal protein S13; 60S ribosomal protein L36; eukaryotic translation initiation factor 3 subunit K; multifunctional protein ADE2; thymidylate synthase; 39S ribosomal protein L14, mitochondrial; uncharacterized LOC552106; 60S ribosomal protein L5; 40S ribosomal protein S23; 60S ribosomal protein L27a; 60S ribosomal protein L13; arginase-1; 40S ribosomal protein S7; DNA-directed RNA polymerase II subunit RPB7; 60S ribosomal protein L22; 60S ribosomal protein L28; 40S ribosomal protein S17; muscle segmentation homeobox; 40S ribosomal protein S11; UDP-sugar transporter UST74c-like; 40S ribosomal protein S6; 60S acidic ribosomal protein P2; 40S ribosomal protein S20; uncharacterized LOC726184; inosine triphosphate pyrophosphatase; 40S ribosomal protein S16; 40S ribosomal protein S26; 60S ribosomal protein L34; dihydroorotate dehydrogenase (quinone), mitochondrial; uncharacterized LOC100578801
Module 2 GO: Biological process GO:0044249 cellular biosynthetic process 72/199 282/960 1.231690 0.0120761 0.1111003 0.2445490 406120 406126 408293 408526 408728 408799 409023 409258 409294 409326 409472 409487 409560 409822 409842 409979 410024 410122 410174 410188 410494 410753 411380 412015 412308 412557 413137 413145 413296 413520 413655 413875 413884 550651 551107 551125 551212 551330 551418 551644 551734 551841 551867 551870 551960 551966 551983 552097 552106 552241 552272 552318 552517 552556 552564 552599 552632 552774 724233 724412 724868 725105 725647 725884 726013 726184 726205 726439 726789 727128 100577081 100578801 ribosomal protein LP1; ribosomal protein S8; exostosin-1; 60S ribosomal protein L4; mediator of RNA polymerase II transcription subunit 18; 40S ribosomal protein S24; methylthioribose-1-phosphate isomerase; eukaryotic translation initiation factor 3 subunit I; 60S ribosomal protein L23; 40S ribosomal protein S2; protein Smaug homolog 1; probable glutamine-dependent NAD(+) synthetase; eukaryotic translation initiation factor 4B; enhancer of split m7 protein-like; eukaryotic translation initiation factor 3 subunit M; DNA replication licensing factor Mcm7; 40S ribosomal protein S19-like; glyceraldehyde-3-phosphate dehydrogenase 2; cyclin-T; 60S ribosomal protein L8; DNA-directed RNA polymerases I, II, and III subunit RPABC2; TATA-box-binding protein-like; 60S ribosomal protein L30; 6-pyruvoyl tetrahydrobiopterin synthase; flap endonuclease 1; diphthine methyl ester synthase; 60S ribosomal protein L15; eukaryotic translation initiation factor 3 subunit F; 40S ribosomal protein S3a; mediator of RNA polymerase II transcription subunit 4; 3-oxoacyl-[acyl-carrier-protein] synthase, mitochondrial; 60S ribosomal protein L31; ubiquitin-40S ribosomal protein S27a; 40S ribosomal protein S4; 60S ribosomal protein L9; 40S ribosomal protein S15Aa; mediator of RNA polymerase II transcription subunit 16; 40S ribosomal protein S3; 60S ribosomal protein L13a; 40S ribosomal protein S15; DNA excision repair protein haywire; probable dolichyl pyrophosphate Glc1Man9GlcNAc2 alpha-1,3-glucosyltransferase; 40S ribosomal protein S13; 60S ribosomal protein L36; eukaryotic translation initiation factor 3 subunit K; multifunctional protein ADE2; thymidylate synthase; 39S ribosomal protein L14, mitochondrial; uncharacterized LOC552106; 60S ribosomal protein L5; 40S ribosomal protein S23; 60S ribosomal protein L27a; 60S ribosomal protein L13; arginase-1; 40S ribosomal protein S7; DNA-directed RNA polymerase II subunit RPB7; 60S ribosomal protein L22; 60S ribosomal protein L28; 40S ribosomal protein S17; muscle segmentation homeobox; 40S ribosomal protein S11; UDP-sugar transporter UST74c-like; 40S ribosomal protein S6; 60S acidic ribosomal protein P2; 40S ribosomal protein S20; uncharacterized LOC726184; inosine triphosphate pyrophosphatase; 40S ribosomal protein S16; 40S ribosomal protein S26; 60S ribosomal protein L34; dihydroorotate dehydrogenase (quinone), mitochondrial; uncharacterized LOC100578801
Module 2 GO: Molecular function GO:0051082 unfolded protein binding 6/263 12/1400 2.661597 0.0139451 0.1673416 0.3824950 408928 409809 409825 411071 411936 551275 heat shock protein 90; T-complex protein 1 subunit beta; T-complex protein 1 subunit epsilon; dnaJ protein homolog 1; prefoldin subunit 5; T-complex protein 1 subunit delta
Module 2 KEGG KEGG:00051 Fructose and mannose metabolism 4/221 6/1081 3.260935 0.0180656 0.1851723 0.3993447 409329 411307 411696 551968 mannose-1-phosphate guanyltransferase beta; mitochondrial enolase superfamily member 1-like; GDP-mannose 4,6 dehydratase; aldose reductase-like
Module 2 GO: Cellular component GO:0043229 intracellular organelle 96/210 447/1126 1.151550 0.0293678 0.1109449 0.2128523 406120 406126 406152 408284 408353 408424 408526 408585 408702 408728 408782 408799 408901 408986 408987 409023 409294 409326 409356 409397 409802 409822 409978 409979 410024 410030 410092 410188 410494 410505 410636 410989 411380 411385 411520 411778 412083 412308 412511 412554 412913 412975 413137 413209 413296 413520 413686 413762 413842 413875 413884 550651 550667 550711 551029 551107 551125 551212 551330 551418 551607 551644 551841 551867 551870 552001 552097 552106 552241 552272 552318 552517 552564 552582 552632 552774 724233 724412 724432 724516 724868 725057 725102 725105 725647 725789 725884 726013 726301 726439 726789 727128 727247 100577081 100578801 100578888 ribosomal protein LP1; ribosomal protein S8; juvenile hormone epoxide hydrolase 1; mitochondrial import receptor subunit TOM40 homolog 1-like; proteasome subunit beta type-7; COP9 signalosome complex subunit 8; 60S ribosomal protein L4; dynactin subunit 6; SAGA-associated factor 29; mediator of RNA polymerase II transcription subunit 18; tubulin beta-1; 40S ribosomal protein S24; actin-related protein 2/3 complex subunit 1A; proteasome subunit alpha type-3; sortilin-related receptor; methylthioribose-1-phosphate isomerase; 60S ribosomal protein L23; 40S ribosomal protein S2; small ribonucleoprotein particle protein B; signal peptidase complex catalytic subunit SEC11A; proteasome subunit alpha type-2; enhancer of split m7 protein-like; proteasome subunit beta type-2-like; DNA replication licensing factor Mcm7; 40S ribosomal protein S19-like; protein SEC13 homolog; dual oxidase maturation factor 1; 60S ribosomal protein L8; DNA-directed RNA polymerases I, II, and III subunit RPABC2; E3 ubiquitin-protein ligase RING1; CDGSH iron-sulfur domain-containing protein 2 homolog; menin; 60S ribosomal protein L30; ester hydrolase C11orf54 homolog; proteasome subunit beta type-4; RNA-binding protein 8A; coatomer subunit gamma; flap endonuclease 1; importin subunit alpha-3; transmembrane emp24 domain-containing protein eca; Golgi SNAP receptor complex member 2; E3 ubiquitin-protein ligase parkin; 60S ribosomal protein L15; dnaJ homolog subfamily C member 2; 40S ribosomal protein S3a; mediator of RNA polymerase II transcription subunit 4; H/ACA ribonucleoprotein complex subunit 1; complement component 1 Q subcomponent-binding protein, mitochondrial; splicing factor U2af 38 kDa subunit; 60S ribosomal protein L31; ubiquitin-40S ribosomal protein S27a; 40S ribosomal protein S4; succinate dehydrogenase [ubiquinone] flavoprotein subunit, mitochondrial; 60S acidic ribosomal protein P0; inhibitor of growth protein 5; 60S ribosomal protein L9; 40S ribosomal protein S15Aa; mediator of RNA polymerase II transcription subunit 16; 40S ribosomal protein S3; 60S ribosomal protein L13a; DNA-directed RNA polymerase II subunit RPB11; 40S ribosomal protein S15; probable dolichyl pyrophosphate Glc1Man9GlcNAc2 alpha-1,3-glucosyltransferase; 40S ribosomal protein S13; 60S ribosomal protein L36; UDP-galactose translocator; 39S ribosomal protein L14, mitochondrial; uncharacterized LOC552106; 60S ribosomal protein L5; 40S ribosomal protein S23; 60S ribosomal protein L27a; 60S ribosomal protein L13; 40S ribosomal protein S7; brahma-associated protein of 60 kDa; 60S ribosomal protein L22; 60S ribosomal protein L28; 40S ribosomal protein S17; muscle segmentation homeobox; ribosomal RNA processing protein 36 homolog; 39S ribosomal protein L50, mitochondrial-like; 40S ribosomal protein S11; coatomer subunit beta; protein dpy-30 homolog; UDP-sugar transporter UST74c-like; 40S ribosomal protein S6; ragulator complex protein LAMTOR1; 60S acidic ribosomal protein P2; 40S ribosomal protein S20; actin-related protein 2/3 complex subunit 4; 40S ribosomal protein S16; 40S ribosomal protein S26; 60S ribosomal protein L34; non-structural maintenance of chromosomes element 1 homolog; dihydroorotate dehydrogenase (quinone), mitochondrial; uncharacterized LOC100578801; zinc finger protein 62 homolog
Module 2 KEGG KEGG:04150 mTOR signaling pathway 12/221 34/1081 1.726377 0.0299287 0.2454151 0.5292650 409050 409393 409560 409725 410030 411295 551198 552381 552720 725647 725789 725855 segment polarity protein dishevelled homolog DVL-3; serine/threonine-protein kinase mTOR; eukaryotic translation initiation factor 4B; target of rapamycin complex subunit lst8; protein SEC13 homolog; V-type proton ATPase subunit D 1; serine/threonine-protein kinase STK11; neutral and basic amino acid transport protein rBAT; V-type proton ATPase subunit E; 40S ribosomal protein S6; ragulator complex protein LAMTOR1; ragulator complex protein LAMTOR3-A
Module 2 GO: Biological process GO:0043170 macromolecule metabolic process 98/199 414/960 1.141942 0.0304780 0.2098314 0.5029268 406120 406126 408293 408353 408424 408526 408728 408799 408986 409169 409234 409258 409294 409326 409397 409472 409560 409770 409802 409822 409842 409978 409979 410024 410026 410174 410188 410385 410494 410664 410753 410763 411076 411090 411380 411458 411520 411695 411778 412308 412388 412427 412557 413137 413145 413213 413296 413481 413520 413686 413842 413854 413875 413884 413889 550651 550901 551029 551107 551125 551212 551330 551418 551644 551734 551841 551867 551870 551960 551992 552097 552106 552241 552272 552318 552517 552559 552564 552599 552632 552774 724233 724412 724432 724868 725352 725647 725789 725884 726013 726184 726359 726439 726782 726789 727128 727247 100578801 ribosomal protein LP1; ribosomal protein S8; exostosin-1; proteasome subunit beta type-7; COP9 signalosome complex subunit 8; 60S ribosomal protein L4; mediator of RNA polymerase II transcription subunit 18; 40S ribosomal protein S24; proteasome subunit alpha type-3; mRNA export factor; S-phase kinase-associated protein 1; eukaryotic translation initiation factor 3 subunit I; 60S ribosomal protein L23; 40S ribosomal protein S2; signal peptidase complex catalytic subunit SEC11A; protein Smaug homolog 1; eukaryotic translation initiation factor 4B; probable tubulin polyglutamylase TTLL1; proteasome subunit alpha type-2; enhancer of split m7 protein-like; eukaryotic translation initiation factor 3 subunit M; proteasome subunit beta type-2-like; DNA replication licensing factor Mcm7; 40S ribosomal protein S19-like; 26S proteasome regulatory complex subunit p48A; cyclin-T; 60S ribosomal protein L8; methionine aminopeptidase 1; DNA-directed RNA polymerases I, II, and III subunit RPABC2; protein arginine N-methyltransferase 5; TATA-box-binding protein-like; deoxyhypusine hydroxylase; UPF0553 protein C9orf64 homolog; tubulin–tyrosine ligase-like protein 12; 60S ribosomal protein L30; histone-arginine methyltransferase CARMER; proteasome subunit beta type-4; proteasome subunit beta type-1; RNA-binding protein 8A; flap endonuclease 1; cell differentiation protein RCD1 homolog; aubergine; diphthine methyl ester synthase; 60S ribosomal protein L15; eukaryotic translation initiation factor 3 subunit F; tubulin polyglutamylase TTLL4-like; 40S ribosomal protein S3a; probable chitinase 3; mediator of RNA polymerase II transcription subunit 4; H/ACA ribonucleoprotein complex subunit 1; splicing factor U2af 38 kDa subunit; xylosyltransferase oxt; 60S ribosomal protein L31; ubiquitin-40S ribosomal protein S27a; cytoplasmic tRNA 2-thiolation protein 1; 40S ribosomal protein S4; protein phosphatase methylesterase 1; inhibitor of growth protein 5; 60S ribosomal protein L9; 40S ribosomal protein S15Aa; mediator of RNA polymerase II transcription subunit 16; 40S ribosomal protein S3; 60S ribosomal protein L13a; 40S ribosomal protein S15; DNA excision repair protein haywire; probable dolichyl pyrophosphate Glc1Man9GlcNAc2 alpha-1,3-glucosyltransferase; 40S ribosomal protein S13; 60S ribosomal protein L36; eukaryotic translation initiation factor 3 subunit K; rRNA 2’-O-methyltransferase fibrillarin; 39S ribosomal protein L14, mitochondrial; uncharacterized LOC552106; 60S ribosomal protein L5; 40S ribosomal protein S23; 60S ribosomal protein L27a; 60S ribosomal protein L13; probable small nuclear ribonucleoprotein Sm D1; 40S ribosomal protein S7; DNA-directed RNA polymerase II subunit RPB7; 60S ribosomal protein L22; 60S ribosomal protein L28; 40S ribosomal protein S17; muscle segmentation homeobox; ribosomal RNA processing protein 36 homolog; 40S ribosomal protein S11; U6 snRNA-associated Sm-like protein LSm7; 40S ribosomal protein S6; ragulator complex protein LAMTOR1; 60S acidic ribosomal protein P2; 40S ribosomal protein S20; uncharacterized LOC726184; protein SMG8; 40S ribosomal protein S16; PEST proteolytic signal-containing nuclear protein-like; 40S ribosomal protein S26; 60S ribosomal protein L34; non-structural maintenance of chromosomes element 1 homolog; uncharacterized LOC100578801
Module 2 GO: Biological process GO:0044248 cellular catabolic process 20/199 65/960 1.484345 0.0319309 0.2098314 0.5029268 406152 408353 408368 408650 408834 408986 409234 409472 409802 409978 410122 411307 411520 411695 412308 412388 725352 726205 726359 727293 juvenile hormone epoxide hydrolase 1; proteasome subunit beta type-7; adenosylhomocysteinase; inositol oxygenase; beclin-1-like protein; proteasome subunit alpha type-3; S-phase kinase-associated protein 1; protein Smaug homolog 1; proteasome subunit alpha type-2; proteasome subunit beta type-2-like; glyceraldehyde-3-phosphate dehydrogenase 2; mitochondrial enolase superfamily member 1-like; proteasome subunit beta type-4; proteasome subunit beta type-1; flap endonuclease 1; cell differentiation protein RCD1 homolog; U6 snRNA-associated Sm-like protein LSm7; inosine triphosphate pyrophosphatase; protein SMG8; guanine deaminase
Module 2 GO: Cellular component GO:0030117 membrane coat 5/210 11/1126 2.437229 0.0376445 0.1158209 0.2128523 408418 410030 411147 412083 725057 AP-2 complex subunit mu; protein SEC13 homolog; AP-2 complex subunit alpha; coatomer subunit gamma; coatomer subunit beta
Module 2 GO: Cellular component GO:0005615 extracellular space 4/210 8/1126 2.680952 0.0441243 0.1158209 0.2128523 406078 408937 413749 100577408 transferrin 1; SPARC; ovalbumin-related protein X; leukocyte elastase inhibitor-like
Module 2 GO: Cellular component GO:0012506 vesicle membrane 3/210 5/1126 3.217143 0.0476910 0.1158209 0.2128523 410030 412083 725057 protein SEC13 homolog; coatomer subunit gamma; coatomer subunit beta
Module 2 GO: Cellular component GO:0030660 Golgi-associated vesicle membrane 3/210 5/1126 3.217143 0.0476910 0.1158209 0.2128523 410030 412083 725057 protein SEC13 homolog; coatomer subunit gamma; coatomer subunit beta
Module 2 GO: Cellular component GO:0030662 coated vesicle membrane 3/210 5/1126 3.217143 0.0476910 0.1158209 0.2128523 410030 412083 725057 protein SEC13 homolog; coatomer subunit gamma; coatomer subunit beta
Module 3 GO: Molecular function GO:0038023 signaling receptor activity 18/117 43/1400 5.008945 0.0000000 0.0000000 0.0000001 406079 406082 406127 406153 408729 409042 409227 410478 410788 411212 411323 411738 412299 412740 413040 551848 552552 100576449 NMDA receptor 1; nicotinic acetylcholine receptor alpha8 subunit; ultraviolet-sensitive opsin; nicotinic acetylcholine receptor alpha2 subunit; uncharacterized LOC408729; corazonin receptor; ultraspiracle; nicotinic acetylcholine receptor beta1 subunit; glutamate receptor ionotropic, kainate 2-like; discoidin domain-containing receptor 2-like; serotonin receptor; lutropin-choriogonadotropic hormone receptor; muscarinic acetylcholine receptor DM1; ligand-gated chloride channel homolog 3; probable G-protein coupled receptor 52; protocadherin-like wing polarity protein stan; uncharacterized LOC552552; protein patched
Module 3 GO: Molecular function GO:0022803 passive transmembrane transporter activity 12/117 19/1400 7.557355 0.0000000 0.0000000 0.0000001 406079 406082 406153 410478 410788 411732 412740 413020 413259 552552 725219 726724 NMDA receptor 1; nicotinic acetylcholine receptor alpha8 subunit; nicotinic acetylcholine receptor alpha2 subunit; nicotinic acetylcholine receptor beta1 subunit; glutamate receptor ionotropic, kainate 2-like; trimeric intracellular cation channel type B; ligand-gated chloride channel homolog 3; two pore potassium channel protein sup-9; neurogenic protein big brain; uncharacterized LOC552552; TWiK family of potassium channels protein 7-like; transient receptor potential channel pyrexia
Module 3 GO: Cellular component GO:0098794 postsynapse 6/111 6/1126 10.144144 0.0000008 0.0000154 0.0000199 406079 406082 406153 410478 410788 552552 NMDA receptor 1; nicotinic acetylcholine receptor alpha8 subunit; nicotinic acetylcholine receptor alpha2 subunit; nicotinic acetylcholine receptor beta1 subunit; glutamate receptor ionotropic, kainate 2-like; uncharacterized LOC552552
Module 3 GO: Cellular component GO:0071944 cell periphery 13/111 31/1126 4.253996 0.0000019 0.0000180 0.0000349 406079 406082 406153 410368 410478 410788 411212 411744 412299 412740 413524 551848 552552 NMDA receptor 1; nicotinic acetylcholine receptor alpha8 subunit; nicotinic acetylcholine receptor alpha2 subunit; cadherin-23; nicotinic acetylcholine receptor beta1 subunit; glutamate receptor ionotropic, kainate 2-like; discoidin domain-containing receptor 2-like; spectrin beta chain; muscarinic acetylcholine receptor DM1; ligand-gated chloride channel homolog 3; exocyst complex component 1; protocadherin-like wing polarity protein stan; uncharacterized LOC552552
Module 3 GO: Cellular component GO:0005886 plasma membrane 11/111 25/1126 4.463423 0.0000072 0.0000301 0.0000902 406079 406082 406153 410368 410478 410788 411212 412299 412740 551848 552552 NMDA receptor 1; nicotinic acetylcholine receptor alpha8 subunit; nicotinic acetylcholine receptor alpha2 subunit; cadherin-23; nicotinic acetylcholine receptor beta1 subunit; glutamate receptor ionotropic, kainate 2-like; discoidin domain-containing receptor 2-like; muscarinic acetylcholine receptor DM1; ligand-gated chloride channel homolog 3; protocadherin-like wing polarity protein stan; uncharacterized LOC552552
Module 3 GO: Cellular component GO:0045211 postsynaptic membrane 5/111 5/1126 10.144144 0.0000086 0.0000301 0.0000902 406079 406082 406153 410478 410788 NMDA receptor 1; nicotinic acetylcholine receptor alpha8 subunit; nicotinic acetylcholine receptor alpha2 subunit; nicotinic acetylcholine receptor beta1 subunit; glutamate receptor ionotropic, kainate 2-like
Module 3 GO: Cellular component GO:0097060 synaptic membrane 5/111 5/1126 10.144144 0.0000086 0.0000301 0.0000902 406079 406082 406153 410478 410788 NMDA receptor 1; nicotinic acetylcholine receptor alpha8 subunit; nicotinic acetylcholine receptor alpha2 subunit; nicotinic acetylcholine receptor beta1 subunit; glutamate receptor ionotropic, kainate 2-like
Module 3 GO: Cellular component GO:0016021 integral component of membrane 67/111 461/1126 1.474312 0.0000111 0.0000301 0.0000909 406079 406082 406127 406153 408329 408500 408613 408729 408908 409042 409056 409087 409089 409139 409164 409511 409640 409691 409931 409957 410368 410478 410485 410613 410788 410902 411199 411212 411323 411732 411738 411750 412299 412465 412740 412965 413020 413030 413040 413133 413259 413689 413916 550899 551375 551765 551848 552139 552194 552477 552552 552612 552721 552735 724220 724552 724679 724761 725011 725219 726095 726322 726724 726941 100576355 100576449 100577325 NMDA receptor 1; nicotinic acetylcholine receptor alpha8 subunit; ultraviolet-sensitive opsin; nicotinic acetylcholine receptor alpha2 subunit; uncharacterized LOC408329; endothelin-converting enzyme 1; synaptotagmin 1; uncharacterized LOC408729; anoctamin-8; corazonin receptor; sodium-dependent phosphate transporter 2; D-beta-hydroxybutyrate dehydrogenase, mitochondrial; vesicular inhibitory amino acid transporter; uncharacterized LOC409139; uncharacterized LOC409164; tetraspanin-1; proton-coupled amino acid transporter 1-like; signal peptide peptidase-like 3; protein FAM69C; synaptotagmin 4; cadherin-23; nicotinic acetylcholine receptor beta1 subunit; transmembrane and TPR repeat-containing protein CG4050-like; major facilitator superfamily domain-containing protein 6; glutamate receptor ionotropic, kainate 2-like; 18-wheeler; sodium-dependent neutral amino acid transporter B(0)AT3; discoidin domain-containing receptor 2-like; serotonin receptor; trimeric intracellular cation channel type B; lutropin-choriogonadotropic hormone receptor; probable E3 ubiquitin-protein ligase HERC4; muscarinic acetylcholine receptor DM1; tetraspanin-7; ligand-gated chloride channel homolog 3; synaptotagmin-14; two pore potassium channel protein sup-9; transmembrane protein 189; probable G-protein coupled receptor 52; heparan sulfate glucosamine 3-O-sulfotransferase 6; neurogenic protein big brain; solute carrier family 12 member 8; transmembrane protein 64; UPF0769 protein C21orf59 homolog; receptor-type tyrosine-protein phosphatase N2; uncharacterized LOC551765; protocadherin-like wing polarity protein stan; 1-acyl-sn-glycerol-3-phosphate acyltransferase alpha-like; transmembrane protein 181; dipeptidyl aminopeptidase-like protein 6; uncharacterized LOC552552; uncharacterized LOC552612; CD63 antigen; uncharacterized LOC552735; synaptotagmin-10; elongation of very long chain fatty acids protein AAEL008004-like; uncharacterized LOC724679; uncharacterized LOC724761; mitochondrial inner membrane protein COX18; TWiK family of potassium channels protein 7-like; galactoside 2-alpha-L-fucosyltransferase 2-like; uncharacterized LOC726322; transient receptor potential channel pyrexia; ATP-binding cassette sub-family A member 2-like; uncharacterized LOC100576355; protein patched; uncharacterized LOC100577325
Module 3 GO: Cellular component GO:0031224 intrinsic component of membrane 67/111 461/1126 1.474312 0.0000111 0.0000301 0.0000909 406079 406082 406127 406153 408329 408500 408613 408729 408908 409042 409056 409087 409089 409139 409164 409511 409640 409691 409931 409957 410368 410478 410485 410613 410788 410902 411199 411212 411323 411732 411738 411750 412299 412465 412740 412965 413020 413030 413040 413133 413259 413689 413916 550899 551375 551765 551848 552139 552194 552477 552552 552612 552721 552735 724220 724552 724679 724761 725011 725219 726095 726322 726724 726941 100576355 100576449 100577325 NMDA receptor 1; nicotinic acetylcholine receptor alpha8 subunit; ultraviolet-sensitive opsin; nicotinic acetylcholine receptor alpha2 subunit; uncharacterized LOC408329; endothelin-converting enzyme 1; synaptotagmin 1; uncharacterized LOC408729; anoctamin-8; corazonin receptor; sodium-dependent phosphate transporter 2; D-beta-hydroxybutyrate dehydrogenase, mitochondrial; vesicular inhibitory amino acid transporter; uncharacterized LOC409139; uncharacterized LOC409164; tetraspanin-1; proton-coupled amino acid transporter 1-like; signal peptide peptidase-like 3; protein FAM69C; synaptotagmin 4; cadherin-23; nicotinic acetylcholine receptor beta1 subunit; transmembrane and TPR repeat-containing protein CG4050-like; major facilitator superfamily domain-containing protein 6; glutamate receptor ionotropic, kainate 2-like; 18-wheeler; sodium-dependent neutral amino acid transporter B(0)AT3; discoidin domain-containing receptor 2-like; serotonin receptor; trimeric intracellular cation channel type B; lutropin-choriogonadotropic hormone receptor; probable E3 ubiquitin-protein ligase HERC4; muscarinic acetylcholine receptor DM1; tetraspanin-7; ligand-gated chloride channel homolog 3; synaptotagmin-14; two pore potassium channel protein sup-9; transmembrane protein 189; probable G-protein coupled receptor 52; heparan sulfate glucosamine 3-O-sulfotransferase 6; neurogenic protein big brain; solute carrier family 12 member 8; transmembrane protein 64; UPF0769 protein C21orf59 homolog; receptor-type tyrosine-protein phosphatase N2; uncharacterized LOC551765; protocadherin-like wing polarity protein stan; 1-acyl-sn-glycerol-3-phosphate acyltransferase alpha-like; transmembrane protein 181; dipeptidyl aminopeptidase-like protein 6; uncharacterized LOC552552; uncharacterized LOC552612; CD63 antigen; uncharacterized LOC552735; synaptotagmin-10; elongation of very long chain fatty acids protein AAEL008004-like; uncharacterized LOC724679; uncharacterized LOC724761; mitochondrial inner membrane protein COX18; TWiK family of potassium channels protein 7-like; galactoside 2-alpha-L-fucosyltransferase 2-like; uncharacterized LOC726322; transient receptor potential channel pyrexia; ATP-binding cassette sub-family A member 2-like; uncharacterized LOC100576355; protein patched; uncharacterized LOC100577325
Module 3 GO: Biological process GO:0007165 signal transduction 18/60 106/960 2.716981 0.0000269 0.0012388 0.0023151 406083 406127 408500 408809 408830 408880 409113 409903 410206 410332 410630 410887 410902 413473 551848 724880 100126690 100576924 tachykinin; ultraviolet-sensitive opsin; endothelin-converting enzyme 1; diacylglycerol kinase theta; muscle M-line assembly protein unc-89; guanylate cyclase, soluble, beta 1; guanine nucleotide-binding protein subunit beta-5; GTP-binding protein RAD-like; differentially expressed in FDCP 8 homolog; breast cancer anti-estrogen resistance protein 3; cGMP-specific 3’,5’-cyclic phosphodiesterase; myotubularin-related protein 13; 18-wheeler; GTPase-activating Rap/Ran-GAP domain-like protein 3; protocadherin-like wing polarity protein stan; allatostatin A; pheromone biosynthesis-activating neuropeptide; ankyrin repeat and death domain-containing protein 1A-like
Module 3 GO: Cellular component GO:0044459 plasma membrane part 7/111 12/1126 5.917417 0.0000394 0.0000936 0.0002904 406079 406082 406153 410478 410788 411212 412299 NMDA receptor 1; nicotinic acetylcholine receptor alpha8 subunit; nicotinic acetylcholine receptor alpha2 subunit; nicotinic acetylcholine receptor beta1 subunit; glutamate receptor ionotropic, kainate 2-like; discoidin domain-containing receptor 2-like; muscarinic acetylcholine receptor DM1
Module 3 KEGG KEGG:04080 Neuroactive ligand-receptor interaction 6/58 14/1081 7.987685 0.0000396 0.0017440 0.0019610 406079 409042 411323 412299 412740 552552 NMDA receptor 1; corazonin receptor; serotonin receptor; muscarinic acetylcholine receptor DM1; ligand-gated chloride channel homolog 3; uncharacterized LOC552552
Module 3 GO: Cellular component GO:0098590 plasma membrane region 5/111 6/1126 8.453454 0.0000474 0.0001000 0.0002910 406079 406082 406153 410478 410788 NMDA receptor 1; nicotinic acetylcholine receptor alpha8 subunit; nicotinic acetylcholine receptor alpha2 subunit; nicotinic acetylcholine receptor beta1 subunit; glutamate receptor ionotropic, kainate 2-like
Module 3 GO: Molecular function GO:0015318 inorganic molecular entity transmembrane transporter activity 13/117 46/1400 3.381642 0.0000478 0.0004943 0.0003843 406079 406082 406153 409056 410478 410788 411199 411732 412740 413020 552552 725219 726724 NMDA receptor 1; nicotinic acetylcholine receptor alpha8 subunit; nicotinic acetylcholine receptor alpha2 subunit; sodium-dependent phosphate transporter 2; nicotinic acetylcholine receptor beta1 subunit; glutamate receptor ionotropic, kainate 2-like; sodium-dependent neutral amino acid transporter B(0)AT3; trimeric intracellular cation channel type B; ligand-gated chloride channel homolog 3; two pore potassium channel protein sup-9; uncharacterized LOC552552; TWiK family of potassium channels protein 7-like; transient receptor potential channel pyrexia
Module 3 GO: Biological process GO:0007186 G-protein coupled receptor signaling pathway 5/60 9/960 8.888889 0.0000841 0.0019338 0.0054207 406083 408500 408809 724880 100126690 tachykinin; endothelin-converting enzyme 1; diacylglycerol kinase theta; allatostatin A; pheromone biosynthesis-activating neuropeptide
Module 3 GO: Biological process GO:0050794 regulation of cellular process 27/60 228/960 1.894737 0.0001505 0.0023074 0.0077617 406083 406086 406127 408500 408809 408830 408880 409113 409903 410206 410332 410468 410630 410887 410902 411744 413473 551848 552145 724220 724301 724551 724880 726648 100126690 100576333 100576924 tachykinin; dorsal; ultraviolet-sensitive opsin; endothelin-converting enzyme 1; diacylglycerol kinase theta; muscle M-line assembly protein unc-89; guanylate cyclase, soluble, beta 1; guanine nucleotide-binding protein subunit beta-5; GTP-binding protein RAD-like; differentially expressed in FDCP 8 homolog; breast cancer anti-estrogen resistance protein 3; protein hairy; cGMP-specific 3’,5’-cyclic phosphodiesterase; myotubularin-related protein 13; 18-wheeler; spectrin beta chain; GTPase-activating Rap/Ran-GAP domain-like protein 3; protocadherin-like wing polarity protein stan; repressor of RNA polymerase III transcription MAF1 homolog; synaptotagmin-10; paired mesoderm homeobox protein 2-like; BRCA1-associated RING domain protein 1-like; allatostatin A; fas apoptotic inhibitory molecule 1; pheromone biosynthesis-activating neuropeptide; nucleoredoxin-like; ankyrin repeat and death domain-containing protein 1A-like
Module 3 GO: Molecular function GO:0015075 ion transmembrane transporter activity 12/117 47/1400 3.055101 0.0002796 0.0021670 0.0020322 406079 406082 406153 410478 410788 411199 411732 412740 413020 552552 725219 726724 NMDA receptor 1; nicotinic acetylcholine receptor alpha8 subunit; nicotinic acetylcholine receptor alpha2 subunit; nicotinic acetylcholine receptor beta1 subunit; glutamate receptor ionotropic, kainate 2-like; sodium-dependent neutral amino acid transporter B(0)AT3; trimeric intracellular cation channel type B; ligand-gated chloride channel homolog 3; two pore potassium channel protein sup-9; uncharacterized LOC552552; TWiK family of potassium channels protein 7-like; transient receptor potential channel pyrexia
Module 3 GO: Biological process GO:0012501 programmed cell death 3/60 5/960 9.600000 0.0021249 0.0244358 0.0456657 724551 724743 726648 BRCA1-associated RING domain protein 1-like; PRKC apoptosis WT1 regulator protein-like; fas apoptotic inhibitory molecule 1
Module 3 KEGG KEGG:04214 Apoptosis - fly 5/58 19/1081 4.904719 0.0024358 0.0535875 0.0602538 408758 409227 409523 413809 100576402 ecdysteroid-regulated gene E74; ultraspiracle; mitogen-activated protein kinase 1; mitogen-activated protein kinase kinase kinase 7; serine/threonine-protein kinase atr-like
Module 3 KEGG KEGG:00020 Citrate cycle (TCA cycle) 4/58 17/1081 4.385395 0.0105173 0.1542536 0.1734431 408446 409155 410396 551958 probable aconitate hydratase, mitochondrial; dihydrolipoyllysine-residue succinyltransferase component of 2-oxoglutarate dehydrogenase complex, mitochondrial-like; isocitrate dehydrogenase [NAD] subunit gamma, mitochondrial; uncharacterized LOC551958
Module 3 KEGG KEGG:01200 Carbon metabolism 6/58 40/1081 2.795690 0.0169304 0.1862344 0.2094023 408446 409155 409682 410396 550785 551958 probable aconitate hydratase, mitochondrial; dihydrolipoyllysine-residue succinyltransferase component of 2-oxoglutarate dehydrogenase complex, mitochondrial-like; NADP-dependent malic enzyme; isocitrate dehydrogenase [NAD] subunit gamma, mitochondrial; fructose-bisphosphate aldolase; uncharacterized LOC551958
Module 3 GO: Biological process GO:0006099 tricarboxylic acid cycle 3/60 10/960 4.800000 0.0203347 0.1870790 0.3277629 408446 409155 410396 probable aconitate hydratase, mitochondrial; dihydrolipoyllysine-residue succinyltransferase component of 2-oxoglutarate dehydrogenase complex, mitochondrial-like; isocitrate dehydrogenase [NAD] subunit gamma, mitochondrial
Module 3 KEGG KEGG:04310 Wnt signaling pathway 4/58 21/1081 3.550082 0.0225143 0.1981256 0.2227728 411738 413809 551313 724997 lutropin-choriogonadotropic hormone receptor; mitogen-activated protein kinase kinase kinase 7; calcineurin subunit B type 2; protein naked cuticle homolog 2-like
Module 3 GO: Biological process GO:0006887 exocytosis 3/60 11/960 4.363636 0.0267324 0.2049482 0.3447069 412965 413524 724220 synaptotagmin-14; exocyst complex component 1; synaptotagmin-10
Module 3 KEGG KEGG:00350 Tyrosine metabolism 2/58 6/1081 6.212644 0.0369259 0.2707900 0.3044768 725400 751102 4-hydroxyphenylpyruvate dioxygenase; tyramine beta hydroxylase
Module 3 GO: Biological process GO:0035556 intracellular signal transduction 7/60 54/960 2.074074 0.0450967 0.2963496 0.4845915 408809 408830 408880 410206 410332 410887 413473 diacylglycerol kinase theta; muscle M-line assembly protein unc-89; guanylate cyclase, soluble, beta 1; differentially expressed in FDCP 8 homolog; breast cancer anti-estrogen resistance protein 3; myotubularin-related protein 13; GTPase-activating Rap/Ran-GAP domain-like protein 3
Module 4 KEGG KEGG:04141 Protein processing in endoplasmic reticulum 22/132 58/1081 3.106322 0.0000002 0.0000113 0.0000127 408557 408706 409377 409587 409613 409911 409968 412045 412141 412505 412526 413441 413976 551559 551853 552295 552378 552747 724587 725571 726087 727262 thioredoxin domain-containing protein 5; heat shock protein 70Cb ortholog; transitional endoplasmic reticulum ATPase TER94; heat shock 70 kDa protein cognate 3; GTP-binding protein SAR1; protein disulfide-isomerase A3; protein transport protein Sec31A; dolichyl-diphosphooligosaccharide–protein glycosyltransferase subunit 2; tumor suppressor candidate 3; translocation protein SEC63 homolog; protein disulfide-isomerase A6; dnaJ homolog subfamily C member 3; derlin-2; translocon-associated protein subunit beta; STT3, subunit of the oligosaccharyltransferase complex, homolog B; translocon-associated protein subunit gamma-like; membrane-associated ring finger (C3HC4) 6; glucosidase 2 subunit beta; nucleotide exchange factor SIL1; protein transport protein Sec61 subunit alpha; ribophorin I; derlin-1-like
Module 4 GO: Biological process GO:0006082 organic acid metabolic process 20/92 64/960 3.260870 0.0000004 0.0000196 0.0000178 409945 410422 411796 411923 412166 412670 412674 412675 412876 412948 550686 550828 551088 551103 551154 552014 552417 552712 724712 725031 aspartate–tRNA ligase, cytoplasmic; dihydrofolate reductase; serine hydroxymethyltransferase; alanine–tRNA ligase, cytoplasmic; acyl-CoA Delta(11) desaturase; probable phosphoserine aminotransferase; phosphoserine phosphatase; aspartate aminotransferase, mitochondrial; pyruvate carboxylase, mitochondrial; delta-1-pyrroline-5-carboxylate synthase; ATP-citrate synthase; elongation of very long chain fatty acids protein AAEL008004-like; asparagine–tRNA ligase, cytoplasmic; probable pyruvate dehydrogenase E1 component subunit alpha, mitochondrial; glucose-6-phosphate isomerase; probable methylthioribulose-1-phosphate dehydratase; acyl-CoA Delta(11) desaturase; 6-phosphogluconate dehydrogenase, decarboxylating; serine–tRNA ligase, mitochondrial; elongation of very long chain fatty acids protein 6
Module 4 GO: Biological process GO:0044283 small molecule biosynthetic process 14/92 40/960 3.652174 0.0000061 0.0001615 0.0002511 410422 410539 411796 412166 412670 412674 412876 412948 550828 551143 551154 552014 552417 725031 dihydrofolate reductase; protein 5NUC-like; serine hydroxymethyltransferase; acyl-CoA Delta(11) desaturase; probable phosphoserine aminotransferase; phosphoserine phosphatase; pyruvate carboxylase, mitochondrial; delta-1-pyrroline-5-carboxylate synthase; elongation of very long chain fatty acids protein AAEL008004-like; inositol-3-phosphate synthase 1-B; glucose-6-phosphate isomerase; probable methylthioribulose-1-phosphate dehydratase; acyl-CoA Delta(11) desaturase; elongation of very long chain fatty acids protein 6
Module 4 KEGG KEGG:01200 Carbon metabolism 15/132 40/1081 3.071023 0.0000254 0.0007364 0.0008286 409736 411796 412670 412674 412675 412876 413867 443552 550804 551103 551154 551276 552712 725325 100577053 methylmalonate-semialdehyde dehydrogenase [acylating]-like protein; serine hydroxymethyltransferase; probable phosphoserine aminotransferase; phosphoserine phosphatase; aspartate aminotransferase, mitochondrial; pyruvate carboxylase, mitochondrial; transaldolase; catalase; transketolase; probable pyruvate dehydrogenase E1 component subunit alpha, mitochondrial; glucose-6-phosphate isomerase; isocitrate dehydrogenase [NADP] cytoplasmic; 6-phosphogluconate dehydrogenase, decarboxylating; glucose-6-phosphate 1-dehydrogenase; glycine dehydrogenase (decarboxylating), mitochondrial
Module 4 KEGG KEGG:01100 Metabolic pathways 59/132 321/1081 1.505216 0.0000686 0.0013270 0.0014932 406076 406114 408642 408817 408955 409515 409736 410422 410530 410539 410554 411662 411715 411796 411897 412045 412141 412663 412670 412674 412675 412815 412876 412889 412948 413228 413356 413601 413763 413867 413942 414008 550686 550687 550804 551103 551143 551154 551276 551837 551853 551872 552014 552148 552242 552286 552328 552712 725031 725146 725325 726087 726156 726818 726880 727078 727599 100577053 100577378 vacuolar H+ ATP synthase 16 kDa proteolipid subunit; alpha-amylase; NAD kinase 2, mitochondrial-like; alanine–glyoxylate aminotransferase 2-like; 4-aminobutyrate aminotransferase, mitochondrial; long-chain-fatty-acid–CoA ligase 4; methylmalonate-semialdehyde dehydrogenase [acylating]-like protein; dihydrofolate reductase; alkaline phosphatase-like; protein 5NUC-like; methylcrotonoyl-CoA carboxylase beta chain, mitochondrial; probable trans-2-enoyl-CoA reductase, mitochondrial; phospholipase D3-like; serine hydroxymethyltransferase; phosphoglucomutase; dolichyl-diphosphooligosaccharide–protein glycosyltransferase subunit 2; tumor suppressor candidate 3; laminin subunit alpha; probable phosphoserine aminotransferase; phosphoserine phosphatase; aspartate aminotransferase, mitochondrial; fatty acid synthase; pyruvate carboxylase, mitochondrial; branched-chain-amino-acid aminotransferase, cytosolic-like; delta-1-pyrroline-5-carboxylate synthase; 5-aminolevulinate synthase, erythroid-specific, mitochondrial; UDP-glucose 6-dehydrogenase; adenine phosphoribosyltransferase; hydroxymethylglutaryl-CoA synthase 1; transaldolase; acyl-CoA synthetase short-chain family member 3, mitochondrial; ribonucleoside-diphosphate reductase subunit M2; ATP-citrate synthase; aldehyde dehydrogenase, mitochondrial; transketolase; probable pyruvate dehydrogenase E1 component subunit alpha, mitochondrial; inositol-3-phosphate synthase 1-B; glucose-6-phosphate isomerase; isocitrate dehydrogenase [NADP] cytoplasmic; long-chain-fatty-acid–CoA ligase ACSBG2; STT3, subunit of the oligosaccharyltransferase complex, homolog B; porphobilinogen deaminase; probable methylthioribulose-1-phosphate dehydratase; thymidylate kinase; uncharacterized LOC552242; acetyl-CoA carboxylase; glycogen [starch] synthase; 6-phosphogluconate dehydrogenase, decarboxylating; elongation of very long chain fatty acids protein 6; very-long-chain enoyl-CoA reductase; glucose-6-phosphate 1-dehydrogenase; ribophorin I; pantothenate kinase 3; beta-hexosaminidase subunit beta-like; pancreatic lipase-related protein 2-like; phospholipid phosphatase 3-like; NADH dehydrogenase [ubiquinone] iron-sulfur protein 4, mitochondrial; glycine dehydrogenase (decarboxylating), mitochondrial; galactokinase-like
Module 4 GO: Cellular component GO:0005783 endoplasmic reticulum 9/115 23/1126 3.831380 0.0002124 0.0053105 0.0190058 409264 409613 409911 411533 412505 413976 551559 552313 727262 ATPase ASNA1 homolog; GTP-binding protein SAR1; protein disulfide-isomerase A3; alpha-2-macroglobulin receptor-associated protein; translocation protein SEC63 homolog; derlin-2; translocon-associated protein subunit beta; sterol O-acyltransferase 1; derlin-1-like
Module 4 KEGG KEGG:01212 Fatty acid metabolism 9/132 20/1081 3.685227 0.0002398 0.0034765 0.0039119 409515 411662 412166 412815 551837 552286 552417 725031 725146 long-chain-fatty-acid–CoA ligase 4; probable trans-2-enoyl-CoA reductase, mitochondrial; acyl-CoA Delta(11) desaturase; fatty acid synthase; long-chain-fatty-acid–CoA ligase ACSBG2; acetyl-CoA carboxylase; acyl-CoA Delta(11) desaturase; elongation of very long chain fatty acids protein 6; very-long-chain enoyl-CoA reductase
Module 4 GO: Biological process GO:0051186 cofactor metabolic process 10/92 31/960 3.366059 0.0003279 0.0048104 0.0070759 408642 410422 411796 413228 550686 551103 551154 552014 552712 725325 NAD kinase 2, mitochondrial-like; dihydrofolate reductase; serine hydroxymethyltransferase; 5-aminolevulinate synthase, erythroid-specific, mitochondrial; ATP-citrate synthase; probable pyruvate dehydrogenase E1 component subunit alpha, mitochondrial; glucose-6-phosphate isomerase; probable methylthioribulose-1-phosphate dehydratase; 6-phosphogluconate dehydrogenase, decarboxylating; glucose-6-phosphate 1-dehydrogenase
Module 4 KEGG KEGG:01230 Biosynthesis of amino acids 10/132 25/1081 3.275758 0.0003445 0.0039960 0.0044964 411796 412670 412674 412675 412876 412889 412948 413867 550804 551276 serine hydroxymethyltransferase; probable phosphoserine aminotransferase; phosphoserine phosphatase; aspartate aminotransferase, mitochondrial; pyruvate carboxylase, mitochondrial; branched-chain-amino-acid aminotransferase, cytosolic-like; delta-1-pyrroline-5-carboxylate synthase; transaldolase; transketolase; isocitrate dehydrogenase [NADP] cytoplasmic
Module 4 GO: Biological process GO:0006520 cellular amino acid metabolic process 11/92 37/960 3.102233 0.0003631 0.0048104 0.0070759 409945 410422 411796 411923 412670 412674 412675 412948 551088 552014 724712 aspartate–tRNA ligase, cytoplasmic; dihydrofolate reductase; serine hydroxymethyltransferase; alanine–tRNA ligase, cytoplasmic; probable phosphoserine aminotransferase; phosphoserine phosphatase; aspartate aminotransferase, mitochondrial; delta-1-pyrroline-5-carboxylate synthase; asparagine–tRNA ligase, cytoplasmic; probable methylthioribulose-1-phosphate dehydratase; serine–tRNA ligase, mitochondrial
Module 4 GO: Biological process GO:0005975 carbohydrate metabolic process 11/92 38/960 3.020595 0.0004707 0.0049896 0.0084854 406114 411100 411897 412876 551143 551154 552328 552712 725325 726445 100577378 alpha-amylase; FGGY carbohydrate kinase domain-containing protein; phosphoglucomutase; pyruvate carboxylase, mitochondrial; inositol-3-phosphate synthase 1-B; glucose-6-phosphate isomerase; glycogen [starch] synthase; 6-phosphogluconate dehydrogenase, decarboxylating; glucose-6-phosphate 1-dehydrogenase; glycerol-3-phosphate dehydrogenase; galactokinase-like
Module 4 GO: Molecular function GO:0019842 vitamin binding 7/144 16/1400 4.253472 0.0005444 0.0168693 0.0720431 408817 411796 412675 412815 412876 413228 724919 alanine–glyoxylate aminotransferase 2-like; serine hydroxymethyltransferase; aspartate aminotransferase, mitochondrial; fatty acid synthase; pyruvate carboxylase, mitochondrial; 5-aminolevulinate synthase, erythroid-specific, mitochondrial; mitochondrial amidoxime reducing component 2-like
Module 4 GO: Biological process GO:0006629 lipid metabolic process 10/92 34/960 3.069054 0.0007581 0.0066966 0.0128619 411706 412166 413763 550686 550828 551143 552417 725031 725146 100576414 phospholipase B1, membrane-associated-like; acyl-CoA Delta(11) desaturase; hydroxymethylglutaryl-CoA synthase 1; ATP-citrate synthase; elongation of very long chain fatty acids protein AAEL008004-like; inositol-3-phosphate synthase 1-B; acyl-CoA Delta(11) desaturase; elongation of very long chain fatty acids protein 6; very-long-chain enoyl-CoA reductase; putative fatty acyl-CoA reductase CG5065
Module 4 GO: Molecular function GO:0016903 oxidoreductase activity, acting on the aldehyde or oxo group of donors 5/144 9/1400 5.401235 0.0009640 0.0168693 0.0720431 409736 412948 550687 551103 100576414 methylmalonate-semialdehyde dehydrogenase [acylating]-like protein; delta-1-pyrroline-5-carboxylate synthase; aldehyde dehydrogenase, mitochondrial; probable pyruvate dehydrogenase E1 component subunit alpha, mitochondrial; putative fatty acyl-CoA reductase CG5065
Module 4 KEGG KEGG:00030 Pentose phosphate pathway 6/132 12/1081 4.094697 0.0014704 0.0142134 0.0159933 411897 413867 550804 551154 552712 725325 phosphoglucomutase; transaldolase; transketolase; glucose-6-phosphate isomerase; 6-phosphogluconate dehydrogenase, decarboxylating; glucose-6-phosphate 1-dehydrogenase
Module 4 KEGG KEGG:01040 Biosynthesis of unsaturated fatty acids 4/132 6/1081 5.459596 0.0026240 0.0217419 0.0244645 412166 552417 725031 725146 acyl-CoA Delta(11) desaturase; acyl-CoA Delta(11) desaturase; elongation of very long chain fatty acids protein 6; very-long-chain enoyl-CoA reductase
Module 4 GO: Molecular function GO:0050662 coenzyme binding 11/144 44/1400 2.430556 0.0035707 0.0366561 0.0987647 408817 410422 411796 412212 412675 412876 413228 413356 724919 725325 726445 alanine–glyoxylate aminotransferase 2-like; dihydrofolate reductase; serine hydroxymethyltransferase; apoptosis-inducing factor 1, mitochondrial; aspartate aminotransferase, mitochondrial; pyruvate carboxylase, mitochondrial; 5-aminolevulinate synthase, erythroid-specific, mitochondrial; UDP-glucose 6-dehydrogenase; mitochondrial amidoxime reducing component 2-like; glucose-6-phosphate 1-dehydrogenase; glycerol-3-phosphate dehydrogenase
Module 4 GO: Molecular function GO:0016746 transferase activity, transferring acyl groups 8/144 27/1400 2.880658 0.0041893 0.0366561 0.0987647 409905 412815 413228 413763 550686 550828 552313 725031 2-acylglycerol O-acyltransferase 1-like; fatty acid synthase; 5-aminolevulinate synthase, erythroid-specific, mitochondrial; hydroxymethylglutaryl-CoA synthase 1; ATP-citrate synthase; elongation of very long chain fatty acids protein AAEL008004-like; sterol O-acyltransferase 1; elongation of very long chain fatty acids protein 6
Module 4 KEGG KEGG:00061 Fatty acid biosynthesis 4/132 7/1081 4.679654 0.0055448 0.0357335 0.0402083 409515 412815 551837 552286 long-chain-fatty-acid–CoA ligase 4; fatty acid synthase; long-chain-fatty-acid–CoA ligase ACSBG2; acetyl-CoA carboxylase
Module 4 KEGG KEGG:04512 ECM-receptor interaction 4/132 7/1081 4.679654 0.0055448 0.0357335 0.0402083 408551 408552 412663 726736 collagen alpha-5(IV) chain; collagen alpha-1(IV) chain; laminin subunit alpha; laminin subunit beta-1
Module 4 GO: Molecular function GO:0070279 vitamin B6 binding 5/144 13/1400 3.739316 0.0069904 0.0489331 0.1160987 408817 411796 412675 413228 724919 alanine–glyoxylate aminotransferase 2-like; serine hydroxymethyltransferase; aspartate aminotransferase, mitochondrial; 5-aminolevulinate synthase, erythroid-specific, mitochondrial; mitochondrial amidoxime reducing component 2-like
Module 4 GO: Biological process GO:0055086 nucleobase-containing small molecule metabolic process 11/92 52/960 2.207358 0.0074910 0.0567177 0.0583937 408642 410539 413601 414008 551154 552014 552148 552316 552511 552712 725325 NAD kinase 2, mitochondrial-like; protein 5NUC-like; adenine phosphoribosyltransferase; ribonucleoside-diphosphate reductase subunit M2; glucose-6-phosphate isomerase; probable methylthioribulose-1-phosphate dehydratase; thymidylate kinase; GMP reductase 1-like; GTP:AMP phosphotransferase AK3, mitochondrial; 6-phosphogluconate dehydrogenase, decarboxylating; glucose-6-phosphate 1-dehydrogenase
Module 4 KEGG KEGG:03050 Proteasome 8/132 26/1081 2.519814 0.0091992 0.0529757 0.0596097 409168 409609 409880 410095 411206 413757 551128 551550 26S proteasome non-ATPase regulatory subunit 13; 26S proteasome non-ATPase regulatory subunit 4; 26S proteasome non-ATPase regulatory subunit 12; proteasome subunit alpha type-7-1; proteasome subunit beta type-5-like; uncharacterized LOC413757; 26S protease regulatory subunit 4; probable 26S proteasome non-ATPase regulatory subunit 3
Module 4 KEGG KEGG:00500 Starch and sucrose metabolism 4/132 8/1081 4.094697 0.0100471 0.0529757 0.0596097 406114 411897 551154 552328 alpha-amylase; phosphoglucomutase; glucose-6-phosphate isomerase; glycogen [starch] synthase
Module 4 GO: Biological process GO:0005996 monosaccharide metabolic process 4/92 10/960 4.173913 0.0105758 0.0700644 0.0726256 412876 551154 725325 100577378 pyruvate carboxylase, mitochondrial; glucose-6-phosphate isomerase; glucose-6-phosphate 1-dehydrogenase; galactokinase-like
Module 4 GO: Cellular component GO:0005789 endoplasmic reticulum membrane 5/115 15/1126 3.263768 0.0132381 0.0690393 0.1840125 412505 413976 551559 552313 727262 translocation protein SEC63 homolog; derlin-2; translocon-associated protein subunit beta; sterol O-acyltransferase 1; derlin-1-like
Module 4 GO: Cellular component GO:0044432 endoplasmic reticulum part 5/115 15/1126 3.263768 0.0132381 0.0690393 0.1840125 412505 413976 551559 552313 727262 translocation protein SEC63 homolog; derlin-2; translocon-associated protein subunit beta; sterol O-acyltransferase 1; derlin-1-like
Module 4 GO: Biological process GO:0044262 cellular carbohydrate metabolic process 3/92 6/960 5.217391 0.0137676 0.0810759 0.0902469 551143 552328 552712 inositol-3-phosphate synthase 1-B; glycogen [starch] synthase; 6-phosphogluconate dehydrogenase, decarboxylating
Module 4 KEGG KEGG:00260 Glycine, serine and threonine metabolism 5/132 13/1081 3.149767 0.0143762 0.0660047 0.0742702 411796 412670 412674 413228 100577053 serine hydroxymethyltransferase; probable phosphoserine aminotransferase; phosphoserine phosphatase; 5-aminolevulinate synthase, erythroid-specific, mitochondrial; glycine dehydrogenase (decarboxylating), mitochondrial
Module 4 KEGG KEGG:00565 Ether lipid metabolism 3/132 5/1081 4.913636 0.0147942 0.0660047 0.0742702 411715 552242 727078 phospholipase D3-like; uncharacterized LOC552242; phospholipid phosphatase 3-like
Module 4 GO: Molecular function GO:0017171 serine hydrolase activity 6/144 21/1400 2.777778 0.0156822 0.0914793 0.1953392 409162 410451 411889 411896 413645 726126 retinoid-inducible serine carboxypeptidase-like; venom serine carboxypeptidase; putative serine protease K12H4.7; prolyl endopeptidase-like; trypsin alpha-3; proclotting enzyme
Module 4 GO: Biological process GO:1901576 organic substance biosynthetic process 37/92 286/960 1.349954 0.0161832 0.0850415 0.1017507 408443 408642 408981 409799 409928 409945 410422 410539 411510 411796 411923 412166 412670 412674 412876 412948 413228 413601 413763 414008 550686 550828 551088 551103 551143 551154 551872 552014 552148 552328 552417 552511 552642 552764 724712 725031 100577998 uncharacterized LOC408443; NAD kinase 2, mitochondrial-like; activating transcription factor 3; ataxin-7-like protein 3; RNA polymerase II elongation factor Ell; aspartate–tRNA ligase, cytoplasmic; dihydrofolate reductase; protein 5NUC-like; DNA-directed RNA polymerases I and III subunit RPAC1; serine hydroxymethyltransferase; alanine–tRNA ligase, cytoplasmic; acyl-CoA Delta(11) desaturase; probable phosphoserine aminotransferase; phosphoserine phosphatase; pyruvate carboxylase, mitochondrial; delta-1-pyrroline-5-carboxylate synthase; 5-aminolevulinate synthase, erythroid-specific, mitochondrial; adenine phosphoribosyltransferase; hydroxymethylglutaryl-CoA synthase 1; ribonucleoside-diphosphate reductase subunit M2; ATP-citrate synthase; elongation of very long chain fatty acids protein AAEL008004-like; asparagine–tRNA ligase, cytoplasmic; probable pyruvate dehydrogenase E1 component subunit alpha, mitochondrial; inositol-3-phosphate synthase 1-B; glucose-6-phosphate isomerase; porphobilinogen deaminase; probable methylthioribulose-1-phosphate dehydratase; thymidylate kinase; glycogen [starch] synthase; acyl-CoA Delta(11) desaturase; GTP:AMP phosphotransferase AK3, mitochondrial; DNA replication licensing factor Mcm3; eukaryotic translation initiation factor 2A; serine–tRNA ligase, mitochondrial; elongation of very long chain fatty acids protein 6; origin recognition complex subunit 3
Module 4 KEGG KEGG:03060 Protein export 4/132 9/1081 3.639731 0.0163914 0.0679073 0.0764111 409587 412505 552114 725571 heat shock 70 kDa protein cognate 3; translocation protein SEC63 homolog; signal recognition particle 54 kDa protein; protein transport protein Sec61 subunit alpha
Module 4 GO: Cellular component GO:0042175 nuclear outer membrane-endoplasmic reticulum membrane network 5/115 16/1126 3.059783 0.0177131 0.0690393 0.1840125 412505 413976 551559 552313 727262 translocation protein SEC63 homolog; derlin-2; translocon-associated protein subunit beta; sterol O-acyltransferase 1; derlin-1-like
Module 4 GO: Molecular function GO:0016614 oxidoreductase activity, acting on CH-OH group of donors 5/144 16/1400 3.038194 0.0183912 0.0919562 0.2114621 412815 413356 552712 725325 726445 fatty acid synthase; UDP-glucose 6-dehydrogenase; 6-phosphogluconate dehydrogenase, decarboxylating; glucose-6-phosphate 1-dehydrogenase; glycerol-3-phosphate dehydrogenase
Module 4 GO: Biological process GO:0006793 phosphorus metabolic process 13/92 74/960 1.833138 0.0184013 0.0850415 0.1105693 408642 410539 414008 550686 551103 551143 551154 552148 552316 552511 552712 725325 726445 NAD kinase 2, mitochondrial-like; protein 5NUC-like; ribonucleoside-diphosphate reductase subunit M2; ATP-citrate synthase; probable pyruvate dehydrogenase E1 component subunit alpha, mitochondrial; inositol-3-phosphate synthase 1-B; glucose-6-phosphate isomerase; thymidylate kinase; GMP reductase 1-like; GTP:AMP phosphotransferase AK3, mitochondrial; 6-phosphogluconate dehydrogenase, decarboxylating; glucose-6-phosphate 1-dehydrogenase; glycerol-3-phosphate dehydrogenase
Module 4 GO: Cellular component GO:0016021 integral component of membrane 58/115 461/1126 1.231878 0.0190797 0.0690393 0.1840125 406076 408523 409041 409905 410429 410530 410844 410878 411105 411266 411902 412094 412166 412212 412431 412505 413000 413117 413189 413840 413976 550691 550828 550886 550914 551036 551165 551180 551217 551324 551388 551559 551795 551844 551936 552256 552295 552313 552401 552417 552746 552747 552769 724497 724919 724952 725031 725146 725245 725324 725420 725571 726987 727078 727262 100576236 100576414 100577231 vacuolar H+ ATP synthase 16 kDa proteolipid subunit; protein TRC8 homolog; transmembrane protein 115; 2-acylglycerol O-acyltransferase 1-like; mannose-P-dolichol utilization defect 1 protein homolog; alkaline phosphatase-like; neuronal membrane glycoprotein M6-a; epoxide hydrolase 4-like; luciferin 4-monooxygenase; nicalin; transmembrane protein 205; protein catecholamines up; acyl-CoA Delta(11) desaturase; apoptosis-inducing factor 1, mitochondrial; thiamine transporter 2-like; translocation protein SEC63 homolog; proton-coupled amino acid transporter 1; proton-coupled amino acid transporter 1; NADH-cytochrome b5 reductase 2; glucose-6-phosphate exchanger SLC37A2; derlin-2; putative inorganic phosphate cotransporter; elongation of very long chain fatty acids protein AAEL008004-like; atlastin; DNA ligase 1-like; vacuole membrane protein 1; innexin inx3; puromycin-sensitive aminopeptidase-like protein; high affinity copper uptake protein 1; transmembrane protein 19; adipokinetic hormone receptor; translocon-associated protein subunit beta; xenotropic and polytropic retrovirus receptor 1 homolog; stromal cell-derived factor 2-like; facilitated trehalose transporter Tret1; peroxisomal membrane protein PEX14; translocon-associated protein subunit gamma-like; sterol O-acyltransferase 1; protein cueball; acyl-CoA Delta(11) desaturase; 17-beta-hydroxysteroid dehydrogenase 13-like; glucosidase 2 subunit beta; ubiA prenyltransferase domain-containing protein 1 homolog; patched domain-containing protein 3-like; mitochondrial amidoxime reducing component 2-like; sodium-independent sulfate anion transporter-like; elongation of very long chain fatty acids protein 6; very-long-chain enoyl-CoA reductase; protein eiger-like; uncharacterized LOC725324; sodium-dependent nutrient amino acid transporter 1-like; protein transport protein Sec61 subunit alpha; uncharacterized LOC726987; phospholipid phosphatase 3-like; derlin-1-like; uncharacterized LOC100576236; putative fatty acyl-CoA reductase CG5065; uncharacterized LOC100577231
Module 4 GO: Cellular component GO:0031224 intrinsic component of membrane 58/115 461/1126 1.231878 0.0190797 0.0690393 0.1840125 406076 408523 409041 409905 410429 410530 410844 410878 411105 411266 411902 412094 412166 412212 412431 412505 413000 413117 413189 413840 413976 550691 550828 550886 550914 551036 551165 551180 551217 551324 551388 551559 551795 551844 551936 552256 552295 552313 552401 552417 552746 552747 552769 724497 724919 724952 725031 725146 725245 725324 725420 725571 726987 727078 727262 100576236 100576414 100577231 vacuolar H+ ATP synthase 16 kDa proteolipid subunit; protein TRC8 homolog; transmembrane protein 115; 2-acylglycerol O-acyltransferase 1-like; mannose-P-dolichol utilization defect 1 protein homolog; alkaline phosphatase-like; neuronal membrane glycoprotein M6-a; epoxide hydrolase 4-like; luciferin 4-monooxygenase; nicalin; transmembrane protein 205; protein catecholamines up; acyl-CoA Delta(11) desaturase; apoptosis-inducing factor 1, mitochondrial; thiamine transporter 2-like; translocation protein SEC63 homolog; proton-coupled amino acid transporter 1; proton-coupled amino acid transporter 1; NADH-cytochrome b5 reductase 2; glucose-6-phosphate exchanger SLC37A2; derlin-2; putative inorganic phosphate cotransporter; elongation of very long chain fatty acids protein AAEL008004-like; atlastin; DNA ligase 1-like; vacuole membrane protein 1; innexin inx3; puromycin-sensitive aminopeptidase-like protein; high affinity copper uptake protein 1; transmembrane protein 19; adipokinetic hormone receptor; translocon-associated protein subunit beta; xenotropic and polytropic retrovirus receptor 1 homolog; stromal cell-derived factor 2-like; facilitated trehalose transporter Tret1; peroxisomal membrane protein PEX14; translocon-associated protein subunit gamma-like; sterol O-acyltransferase 1; protein cueball; acyl-CoA Delta(11) desaturase; 17-beta-hydroxysteroid dehydrogenase 13-like; glucosidase 2 subunit beta; ubiA prenyltransferase domain-containing protein 1 homolog; patched domain-containing protein 3-like; mitochondrial amidoxime reducing component 2-like; sodium-independent sulfate anion transporter-like; elongation of very long chain fatty acids protein 6; very-long-chain enoyl-CoA reductase; protein eiger-like; uncharacterized LOC725324; sodium-dependent nutrient amino acid transporter 1-like; protein transport protein Sec61 subunit alpha; uncharacterized LOC726987; phospholipid phosphatase 3-like; derlin-1-like; uncharacterized LOC100576236; putative fatty acyl-CoA reductase CG5065; uncharacterized LOC100577231
Module 4 GO: Cellular component GO:0000502 proteasome complex 4/115 11/1126 3.560474 0.0193310 0.0690393 0.1840125 410095 411206 413757 551550 proteasome subunit alpha type-7-1; proteasome subunit beta type-5-like; uncharacterized LOC413757; probable 26S proteasome non-ATPase regulatory subunit 3
Module 4 KEGG KEGG:00520 Amino sugar and nucleotide sugar metabolism 6/132 19/1081 2.586124 0.0208348 0.0805614 0.0906498 411897 413189 413356 551154 726818 100577378 phosphoglucomutase; NADH-cytochrome b5 reductase 2; UDP-glucose 6-dehydrogenase; glucose-6-phosphate isomerase; beta-hexosaminidase subunit beta-like; galactokinase-like
Module 4 GO: Biological process GO:0019637 organophosphate metabolic process 11/92 60/960 1.913043 0.0220585 0.0850415 0.1168592 408642 410539 414008 551143 551154 552148 552316 552511 552712 725325 726445 NAD kinase 2, mitochondrial-like; protein 5NUC-like; ribonucleoside-diphosphate reductase subunit M2; inositol-3-phosphate synthase 1-B; glucose-6-phosphate isomerase; thymidylate kinase; GMP reductase 1-like; GTP:AMP phosphotransferase AK3, mitochondrial; 6-phosphogluconate dehydrogenase, decarboxylating; glucose-6-phosphate 1-dehydrogenase; glycerol-3-phosphate dehydrogenase
Module 4 GO: Biological process GO:0006575 cellular modified amino acid metabolic process 3/92 7/960 4.472050 0.0224344 0.0850415 0.1168592 410422 411796 552014 dihydrofolate reductase; serine hydroxymethyltransferase; probable methylthioribulose-1-phosphate dehydratase
Module 4 GO: Biological process GO:0044249 cellular biosynthetic process 36/92 282/960 1.332100 0.0224638 0.0850415 0.1168592 408443 408642 408981 409799 409928 409945 410422 410539 411510 411796 411923 412166 412670 412674 412948 413228 413601 413763 414008 550686 550828 551088 551103 551143 551154 551872 552014 552148 552328 552417 552511 552642 552764 724712 725031 100577998 uncharacterized LOC408443; NAD kinase 2, mitochondrial-like; activating transcription factor 3; ataxin-7-like protein 3; RNA polymerase II elongation factor Ell; aspartate–tRNA ligase, cytoplasmic; dihydrofolate reductase; protein 5NUC-like; DNA-directed RNA polymerases I and III subunit RPAC1; serine hydroxymethyltransferase; alanine–tRNA ligase, cytoplasmic; acyl-CoA Delta(11) desaturase; probable phosphoserine aminotransferase; phosphoserine phosphatase; delta-1-pyrroline-5-carboxylate synthase; 5-aminolevulinate synthase, erythroid-specific, mitochondrial; adenine phosphoribosyltransferase; hydroxymethylglutaryl-CoA synthase 1; ribonucleoside-diphosphate reductase subunit M2; ATP-citrate synthase; elongation of very long chain fatty acids protein AAEL008004-like; asparagine–tRNA ligase, cytoplasmic; probable pyruvate dehydrogenase E1 component subunit alpha, mitochondrial; inositol-3-phosphate synthase 1-B; glucose-6-phosphate isomerase; porphobilinogen deaminase; probable methylthioribulose-1-phosphate dehydratase; thymidylate kinase; glycogen [starch] synthase; acyl-CoA Delta(11) desaturase; GTP:AMP phosphotransferase AK3, mitochondrial; DNA replication licensing factor Mcm3; eukaryotic translation initiation factor 2A; serine–tRNA ligase, mitochondrial; elongation of very long chain fatty acids protein 6; origin recognition complex subunit 3
Module 4 GO: Cellular component GO:1905368 peptidase complex 5/115 17/1126 2.879795 0.0230885 0.0721516 0.1878012 409799 410095 411206 413757 551550 ataxin-7-like protein 3; proteasome subunit alpha type-7-1; proteasome subunit beta type-5-like; uncharacterized LOC413757; probable 26S proteasome non-ATPase regulatory subunit 3
Module 4 GO: Biological process GO:0044255 cellular lipid metabolic process 6/92 25/960 2.504348 0.0259888 0.0918273 0.1315040 412166 413763 550828 551143 552417 725031 acyl-CoA Delta(11) desaturase; hydroxymethylglutaryl-CoA synthase 1; elongation of very long chain fatty acids protein AAEL008004-like; inositol-3-phosphate synthase 1-B; acyl-CoA Delta(11) desaturase; elongation of very long chain fatty acids protein 6
Module 4 KEGG KEGG:00280 Valine, leucine and isoleucine degradation 6/132 21/1081 2.339827 0.0339122 0.1204778 0.1355648 408955 409736 410554 412889 413763 550687 4-aminobutyrate aminotransferase, mitochondrial; methylmalonate-semialdehyde dehydrogenase [acylating]-like protein; methylcrotonoyl-CoA carboxylase beta chain, mitochondrial; branched-chain-amino-acid aminotransferase, cytosolic-like; hydroxymethylglutaryl-CoA synthase 1; aldehyde dehydrogenase, mitochondrial
Module 4 KEGG KEGG:00510 N-Glycan biosynthesis 4/132 11/1081 2.977961 0.0353124 0.1204778 0.1355648 412045 412141 551853 726087 dolichyl-diphosphooligosaccharide–protein glycosyltransferase subunit 2; tumor suppressor candidate 3; STT3, subunit of the oligosaccharyltransferase complex, homolog B; ribophorin I
Module 4 GO: Molecular function GO:0016875 ligase activity, forming carbon-oxygen bonds 4/144 13/1400 2.991453 0.0366761 0.1604580 0.3364074 409945 411923 551088 724712 aspartate–tRNA ligase, cytoplasmic; alanine–tRNA ligase, cytoplasmic; asparagine–tRNA ligase, cytoplasmic; serine–tRNA ligase, mitochondrial
Module 4 KEGG KEGG:00062 Fatty acid elongation 3/132 7/1081 3.509740 0.0430289 0.1386486 0.1560111 411662 725031 725146 probable trans-2-enoyl-CoA reductase, mitochondrial; elongation of very long chain fatty acids protein 6; very-long-chain enoyl-CoA reductase
Module 4 GO: Cellular component GO:0012505 endomembrane system 11/115 63/1126 1.709593 0.0479692 0.1332479 0.3576653 409264 409613 409911 411533 412505 413976 551559 552313 552346 724795 727262 ATPase ASNA1 homolog; GTP-binding protein SAR1; protein disulfide-isomerase A3; alpha-2-macroglobulin receptor-associated protein; translocation protein SEC63 homolog; derlin-2; translocon-associated protein subunit beta; sterol O-acyltransferase 1; coatomer subunit delta; WAS protein family homolog 1-like; derlin-1-like
Module 5 GO: Biological process GO:0046907 intracellular transport 8/44 60/960 2.909091 0.0043197 0.0462494 0.0745260 408391 410493 413344 413614 413845 551140 552830 726833 AP-1 complex subunit mu-1; vacuolar protein sorting-associated protein 11 homolog; exportin-5; ras-related protein Rab-14; mitochondrial import receptor subunit TOM20 homolog; signal transducing adapter molecule 1; alpha-soluble NSF attachment protein; TOM1-like protein 2
Module 5 KEGG KEGG:04120 Ubiquitin mediated proteolysis 7/50 47/1081 3.220000 0.0044720 0.1477696 0.1675121 409225 409607 410565 410838 411182 551174 551511 NEDD8-conjugating enzyme Ubc12; ubiquitin-conjugating enzyme E2 Q2; cullin-1; ubiquitin-conjugating enzyme E2 R2; ubiquitin-protein ligase E3A; E3 SUMO-protein ligase PIAS3; transcription elongation factor B polypeptide 2
Module 5 GO: Biological process GO:0070727 cellular macromolecule localization 7/44 49/960 3.116883 0.0052370 0.0462494 0.0745260 408391 410493 413344 413845 551140 552830 726833 AP-1 complex subunit mu-1; vacuolar protein sorting-associated protein 11 homolog; exportin-5; mitochondrial import receptor subunit TOM20 homolog; signal transducing adapter molecule 1; alpha-soluble NSF attachment protein; TOM1-like protein 2
Module 5 GO: Biological process GO:0051649 establishment of localization in cell 8/44 62/960 2.815249 0.0053229 0.0462494 0.0745260 408391 410493 413344 413614 413845 551140 552830 726833 AP-1 complex subunit mu-1; vacuolar protein sorting-associated protein 11 homolog; exportin-5; ras-related protein Rab-14; mitochondrial import receptor subunit TOM20 homolog; signal transducing adapter molecule 1; alpha-soluble NSF attachment protein; TOM1-like protein 2
Module 5 KEGG KEGG:04142 Lysosome 5/50 28/1081 3.860714 0.0075779 0.1477696 0.1675121 406108 408391 551012 552375 725899 tetraspanin 6; AP-1 complex subunit mu-1; cation-independent mannose-6-phosphate receptor; Niemann-Pick C1 protein; alpha-N-acetylgalactosaminidase
Module 5 GO: Biological process GO:0032535 regulation of cellular component size 3/44 10/960 6.545454 0.0086108 0.0462494 0.0745260 409218 409581 552486 neural Wiskott-Aldrich syndrome protein; F-actin-capping protein subunit beta; F-actin-capping protein subunit alpha
Module 5 GO: Biological process GO:0032970 regulation of actin filament-based process 3/44 10/960 6.545454 0.0086108 0.0462494 0.0745260 409218 409581 552486 neural Wiskott-Aldrich syndrome protein; F-actin-capping protein subunit beta; F-actin-capping protein subunit alpha
Module 5 GO: Biological process GO:0043254 regulation of protein complex assembly 3/44 10/960 6.545454 0.0086108 0.0462494 0.0745260 409218 409581 552486 neural Wiskott-Aldrich syndrome protein; F-actin-capping protein subunit beta; F-actin-capping protein subunit alpha
Module 5 GO: Biological process GO:0044087 regulation of cellular component biogenesis 3/44 10/960 6.545454 0.0086108 0.0462494 0.0745260 409218 409581 552486 neural Wiskott-Aldrich syndrome protein; F-actin-capping protein subunit beta; F-actin-capping protein subunit alpha
Module 5 GO: Biological process GO:0090066 regulation of anatomical structure size 3/44 10/960 6.545454 0.0086108 0.0462494 0.0745260 409218 409581 552486 neural Wiskott-Aldrich syndrome protein; F-actin-capping protein subunit beta; F-actin-capping protein subunit alpha
Module 5 GO: Molecular function GO:0004721 phosphoprotein phosphatase activity 4/65 19/1400 4.534413 0.0096915 0.1506384 0.2560559 408701 409430 550710 551854 protein phosphatase 1H; serine/threonine-protein phosphatase alpha-2 isoform; serine/threonine-protein phosphatase 2A catalytic subunit alpha isoform; serine/threonine-protein phosphatase 5
Module 5 GO: Biological process GO:0045184 establishment of protein localization 8/44 69/960 2.529644 0.0103044 0.0462494 0.0859993 408391 410493 413344 413845 551140 552830 726833 100576745 AP-1 complex subunit mu-1; vacuolar protein sorting-associated protein 11 homolog; exportin-5; mitochondrial import receptor subunit TOM20 homolog; signal transducing adapter molecule 1; alpha-soluble NSF attachment protein; TOM1-like protein 2; leucine-rich repeat-containing protein 26-like
Module 5 GO: Biological process GO:0042592 homeostatic process 4/44 20/960 4.363636 0.0108764 0.0462494 0.0862321 411391 552501 726237 726649 thioredoxin-related transmembrane protein 2 homolog; transmembrane and coiled-coil domain-containing protein 1; protein disulfide-isomerase TMX3; thioredoxin domain-containing protein 15
Module 5 GO: Biological process GO:0008104 protein localization 8/44 70/960 2.493507 0.0112337 0.0462494 0.0862321 408391 410493 413344 413845 551140 552830 726833 100576745 AP-1 complex subunit mu-1; vacuolar protein sorting-associated protein 11 homolog; exportin-5; mitochondrial import receptor subunit TOM20 homolog; signal transducing adapter molecule 1; alpha-soluble NSF attachment protein; TOM1-like protein 2; leucine-rich repeat-containing protein 26-like
Module 5 GO: Biological process GO:0006810 transport 13/44 149/960 1.903600 0.0118084 0.0462494 0.0862321 408391 408828 409476 410493 412806 413344 413614 413845 551140 552830 726431 726833 100576745 AP-1 complex subunit mu-1; uncharacterized MFS-type transporter C09D4.1; nuclear cap-binding protein subunit 1; vacuolar protein sorting-associated protein 11 homolog; vesicle transport protein GOT1B; exportin-5; ras-related protein Rab-14; mitochondrial import receptor subunit TOM20 homolog; signal transducing adapter molecule 1; alpha-soluble NSF attachment protein; uncharacterized LOC726431; TOM1-like protein 2; leucine-rich repeat-containing protein 26-like
Module 5 KEGG KEGG:04933 AGE-RAGE signaling pathway in diabetic complications 3/50 12/1081 5.405000 0.0152561 0.1983298 0.2248273 413430 413742 551554 RAC serine/threonine-protein kinase; signal transducer and activator of transcription 5B; ras-related protein Rac1
Module 5 GO: Biological process GO:0097435 supramolecular fiber organization 3/44 13/960 5.034965 0.0186288 0.0589261 0.0955373 409218 409581 552486 neural Wiskott-Aldrich syndrome protein; F-actin-capping protein subunit beta; F-actin-capping protein subunit alpha
Module 5 GO: Biological process GO:0022411 cellular component disassembly 2/44 5/960 8.727273 0.0188062 0.0589261 0.0955373 409581 552486 F-actin-capping protein subunit beta; F-actin-capping protein subunit alpha
Module 5 GO: Biological process GO:0051129 negative regulation of cellular component organization 2/44 5/960 8.727273 0.0188062 0.0589261 0.0955373 409581 552486 F-actin-capping protein subunit beta; F-actin-capping protein subunit alpha
Module 5 GO: Molecular function GO:0070279 vitamin B6 binding 3/65 13/1400 4.970414 0.0195674 0.1506384 0.2560559 409196 409927 410638 alanine aminotransferase 1; putative pyridoxal-dependent decarboxylase domain-containing protein 2; aromatic-L-amino-acid decarboxylase
Module 5 GO: Biological process GO:0030036 actin cytoskeleton organization 3/44 14/960 4.675325 0.0229589 0.0674419 0.1117738 409218 409581 552486 neural Wiskott-Aldrich syndrome protein; F-actin-capping protein subunit beta; F-actin-capping protein subunit alpha
Module 5 GO: Biological process GO:0045454 cell redox homeostasis 3/44 15/960 4.363636 0.0277918 0.0725676 0.1273434 411391 726237 726649 thioredoxin-related transmembrane protein 2 homolog; protein disulfide-isomerase TMX3; thioredoxin domain-containing protein 15
Module 5 GO: Biological process GO:0051128 regulation of cellular component organization 3/44 15/960 4.363636 0.0277918 0.0725676 0.1273434 409218 409581 552486 neural Wiskott-Aldrich syndrome protein; F-actin-capping protein subunit beta; F-actin-capping protein subunit alpha
Module 5 GO: Molecular function GO:0016830 carbon-carbon lyase activity 2/65 6/1400 7.179487 0.0282176 0.1506384 0.2560559 409927 410638 putative pyridoxal-dependent decarboxylase domain-containing protein 2; aromatic-L-amino-acid decarboxylase
Module 5 GO: Molecular function GO:0008092 cytoskeletal protein binding 4/65 26/1400 3.313610 0.0292798 0.1506384 0.2560559 409218 409581 552486 725218 neural Wiskott-Aldrich syndrome protein; F-actin-capping protein subunit beta; F-actin-capping protein subunit alpha; growth arrest-specific protein 2-like
Module 5 GO: Molecular function GO:0016788 hydrolase activity, acting on ester bonds 6/65 52/1400 2.485207 0.0300237 0.1506384 0.2560559 408701 408840 409430 413429 550710 551854 protein phosphatase 1H; 5’-3’ exoribonuclease 2 homolog; serine/threonine-protein phosphatase alpha-2 isoform; acid phosphatase type 7; serine/threonine-protein phosphatase 2A catalytic subunit alpha isoform; serine/threonine-protein phosphatase 5
Module 5 KEGG KEGG:04144 Endocytosis 6/50 54/1081 2.402222 0.0339182 0.3307020 0.3748849 409218 409581 410241 551012 551140 552486 neural Wiskott-Aldrich syndrome protein; F-actin-capping protein subunit beta; ras-related protein Rab-10; cation-independent mannose-6-phosphate receptor; signal transducing adapter molecule 1; F-actin-capping protein subunit alpha
Module 5 GO: Molecular function GO:0019842 vitamin binding 3/65 16/1400 4.038462 0.0346866 0.1506384 0.2560559 409196 409927 410638 alanine aminotransferase 1; putative pyridoxal-dependent decarboxylase domain-containing protein 2; aromatic-L-amino-acid decarboxylase
Module 5 GO: Cellular component GO:0016021 integral component of membrane 34/65 461/1126 1.277624 0.0375885 0.4322677 0.9957147 406108 408303 408751 408828 409136 409145 409263 409310 409976 410507 410825 411391 411408 412024 412291 412636 412806 413164 413740 413845 550918 551466 551678 551890 552067 552098 552501 724286 724585 725316 727001 100576745 100578046 100578526 tetraspanin 6; protein lifeguard 1; E3 ubiquitin-protein ligase RNF185-like; uncharacterized MFS-type transporter C09D4.1; 72 kDa inositol polyphosphate 5-phosphatase; zinc transporter ZIP9; glycoprotein-N-acetylgalactosamine 3-beta-galactosyltransferase 1; CSC1-like protein 2; transmembrane emp24 domain-containing protein 5; sodium-independent sulfate anion transporter-like; leucine-rich repeat and immunoglobulin-like domain-containing nogo receptor-interacting protein 3; thioredoxin-related transmembrane protein 2 homolog; CDP-diacylglycerol–inositol 3-phosphatidyltransferase; probable palmitoyltransferase ZDHHC16; uncharacterized protein KIAA2013 homolog; protein ABHD13; vesicle transport protein GOT1B; membrane-associated progesterone receptor component 1; iodotyrosine deiodinase 1; mitochondrial import receptor subunit TOM20 homolog; ATP-binding cassette sub-family G member 4; CAAX prenyl protease 1 homolog; receptor expression-enhancing protein 5-like; probable serine incorporator; uncharacterized LOC552067; syntaxin-8; transmembrane and coiled-coil domain-containing protein 1; uncharacterized LOC724286; uncharacterized LOC724585; transmembrane protein 208; solute carrier family 35 member C2-like; leucine-rich repeat-containing protein 26-like; probable G-protein coupled receptor Mth-like 1; solute carrier family 35 member E2-like
Module 5 GO: Cellular component GO:0031224 intrinsic component of membrane 34/65 461/1126 1.277624 0.0375885 0.4322677 0.9957147 406108 408303 408751 408828 409136 409145 409263 409310 409976 410507 410825 411391 411408 412024 412291 412636 412806 413164 413740 413845 550918 551466 551678 551890 552067 552098 552501 724286 724585 725316 727001 100576745 100578046 100578526 tetraspanin 6; protein lifeguard 1; E3 ubiquitin-protein ligase RNF185-like; uncharacterized MFS-type transporter C09D4.1; 72 kDa inositol polyphosphate 5-phosphatase; zinc transporter ZIP9; glycoprotein-N-acetylgalactosamine 3-beta-galactosyltransferase 1; CSC1-like protein 2; transmembrane emp24 domain-containing protein 5; sodium-independent sulfate anion transporter-like; leucine-rich repeat and immunoglobulin-like domain-containing nogo receptor-interacting protein 3; thioredoxin-related transmembrane protein 2 homolog; CDP-diacylglycerol–inositol 3-phosphatidyltransferase; probable palmitoyltransferase ZDHHC16; uncharacterized protein KIAA2013 homolog; protein ABHD13; vesicle transport protein GOT1B; membrane-associated progesterone receptor component 1; iodotyrosine deiodinase 1; mitochondrial import receptor subunit TOM20 homolog; ATP-binding cassette sub-family G member 4; CAAX prenyl protease 1 homolog; receptor expression-enhancing protein 5-like; probable serine incorporator; uncharacterized LOC552067; syntaxin-8; transmembrane and coiled-coil domain-containing protein 1; uncharacterized LOC724286; uncharacterized LOC724585; transmembrane protein 208; solute carrier family 35 member C2-like; leucine-rich repeat-containing protein 26-like; probable G-protein coupled receptor Mth-like 1; solute carrier family 35 member E2-like
Module 5 GO: Molecular function GO:0019787 ubiquitin-like protein transferase activity 3/65 17/1400 3.800905 0.0407516 0.1506384 0.2560559 411182 413468 551174 ubiquitin-protein ligase E3A; protein ariadne-1; E3 SUMO-protein ligase PIAS3
Module 5 GO: Molecular function GO:0001882 nucleoside binding 6/65 57/1400 2.267206 0.0446336 0.1506384 0.2560559 410241 411085 411704 413614 551554 724676 ras-related protein Rab-10; ADP-ribosylation factor-like protein 2; guanine nucleotide-binding protein G(i) subunit alpha; ras-related protein Rab-14; ras-related protein Rac1; ADP-ribosylation factor-like protein 1
Module 5 KEGG KEGG:00250 Alanine, aspartate and glutamate metabolism 2/50 8/1081 5.405000 0.0491201 0.3831368 0.4343252 409196 410482 alanine aminotransferase 1; adenylosuccinate lyase
Module 6 GO: Molecular function GO:0001882 nucleoside binding 9/57 57/1400 3.878116 0.0003174 0.0082528 0.0038424 409529 410906 410969 550723 551185 551731 552196 552448 724873 ras-like protein 2; guanine nucleotide-binding protein subunit alpha homolog; ras-related protein Rab-9A; ras-related protein Rab-39B; GTP-binding protein 1; rho GTPase-activating protein 190; ras-related protein Rab-43; ADP-ribosylation factor-like protein 8B-A; ras-related protein Rab-7a
Module 6 GO: Molecular function GO:0016817 hydrolase activity, acting on acid anhydrides 10/57 107/1400 2.295458 0.0090480 0.1176243 0.0730191 409529 410463 410676 410906 410969 550723 551185 551731 552196 724873 ras-like protein 2; ATPase WRNIP1-like; adenylate kinase isoenzyme 6; guanine nucleotide-binding protein subunit alpha homolog; ras-related protein Rab-9A; ras-related protein Rab-39B; GTP-binding protein 1; rho GTPase-activating protein 190; ras-related protein Rab-43; ras-related protein Rab-7a
Module 6 KEGG KEGG:03410 Base excision repair 2/33 9/1081 7.279461 0.0284604 0.4603898 0.5139918 725801 100577027 G/T mismatch-specific thymine DNA glycosylase-like; DNA repair protein XRCC1
Module 6 GO: Biological process GO:0007275 multicellular organism development 2/34 8/960 7.058823 0.0298325 0.5328338 0.6676729 410808 412008 E3 ubiquitin-protein ligase Siah1; sprouty-related, EVH1 domain-containing protein 1
Module 6 KEGG KEGG:04140 Autophagy - animal 4/33 40/1081 3.275758 0.0302736 0.4603898 0.5139918 408358 409529 409925 724873 RB1-inducible coiled-coil protein 1; ras-like protein 2; dual specificity mitogen-activated protein kinase kinase dSOR1; ras-related protein Rab-7a
Module 6 GO: Molecular function GO:0004540 ribonuclease activity 2/57 8/1400 6.140351 0.0389514 0.2712372 0.2357583 100576272 100576289 tRNA-splicing endonuclease subunit Sen34; uncharacterized LOC100576289
Module 6 GO: Molecular function GO:0003676 nucleic acid binding 19/57 319/1400 1.462905 0.0417288 0.2712372 0.2377121 408678 410463 412545 413515 551421 551877 724212 725326 725512 726215 727285 100576272 100576289 100576411 100576565 100576908 100577027 100577561 100577696 OTU domain-containing protein 7B-like; ATPase WRNIP1-like; zinc finger protein 277; zinc finger protein 62-like; tRNA selenocysteine 1-associated protein 1-like; putative high mobility group protein B1-like 1; 60 kDa SS-A/Ro ribonucleoprotein-like; tRNA pseudouridine synthase-like 1; RISC-loading complex subunit TARBP2; uncharacterized LOC726215; zinc finger protein 227-like; tRNA-splicing endonuclease subunit Sen34; uncharacterized LOC100576289; uncharacterized LOC100576411; zinc finger protein 511; polycomb protein Asx; DNA repair protein XRCC1; uncharacterized LOC100577561; fez family zinc finger protein 2-like
Module 6 KEGG KEGG:04350 TGF-beta signaling pathway 2/33 11/1081 5.955923 0.0418536 0.4603898 0.5139918 410776 412866 protein 60A; E3 ubiquitin-protein ligase SMURF2
Module 7 GO: Biological process GO:0035556 intracellular signal transduction 6/23 54/960 4.637681 0.0011519 0.0380135 0.2050427 408373 412143 413034 413071 413448 413772 phosphatidylinositol 4-kinase beta; rho guanine nucleotide exchange factor 18; rho-related BTB domain-containing protein 1; eye-specific diacylglycerol kinase; raf homolog serine/threonine-protein kinase phl; suppressor of cytokine signaling 7
Module 7 KEGG KEGG:04068 FoxO signaling pathway 4/35 21/1081 5.882993 0.0037303 0.0687688 0.0701261 408438 413183 413448 552793 insulin receptor substrate 1-B; G1/S-specific cyclin-D2; raf homolog serine/threonine-protein kinase phl; F-box only protein 32
Module 7 KEGG KEGG:04320 Dorso-ventral axis formation 3/35 11/1081 8.423377 0.0042981 0.0687688 0.0701261 413448 727422 100577214 raf homolog serine/threonine-protein kinase phl; beta-1,4-mannosyltransferase egh; protein giant-lens
Module 7 KEGG KEGG:04080 Neuroactive ligand-receptor interaction 3/35 14/1081 6.618367 0.0088670 0.0766655 0.0781787 406070 406151 552518 dopamine receptor 2; metabotropic glutamate receptor 1; serotonin receptor
Module 7 KEGG KEGG:00511 Other glycan degradation 2/35 5/1081 12.354286 0.0095832 0.0766655 0.0781787 412838 725756 alpha-mannosidase 2; beta-galactosidase-like
Module 7 KEGG KEGG:04070 Phosphatidylinositol signaling system 3/35 19/1081 4.876692 0.0211183 0.1295980 0.1321559 408373 413071 724991 phosphatidylinositol 4-kinase beta; eye-specific diacylglycerol kinase; phosphatidylinositol 4-phosphate 5-kinase type-1 alpha
Module 7 KEGG KEGG:00562 Inositol phosphate metabolism 3/35 20/1081 4.632857 0.0242996 0.1295980 0.1321559 408373 724991 100577002 phosphatidylinositol 4-kinase beta; phosphatidylinositol 4-phosphate 5-kinase type-1 alpha; multiple inositol polyphosphate phosphatase 1-like
Module 7 GO: Biological process GO:0007165 signal transduction 6/23 106/960 2.362592 0.0330865 0.5459279 0.7498662 408373 412143 413034 413071 413448 413772 phosphatidylinositol 4-kinase beta; rho guanine nucleotide exchange factor 18; rho-related BTB domain-containing protein 1; eye-specific diacylglycerol kinase; raf homolog serine/threonine-protein kinase phl; suppressor of cytokine signaling 7
Module 8 KEGG KEGG:00190 Oxidative phosphorylation 26/29 47/1081 20.620690 0.0000000 0.0000000 0.0000000 408367 408477 409114 409236 409473 409549 409930 411183 411411 412328 412396 413014 413605 551078 551660 551757 551766 551866 552424 552682 552699 724264 724719 725712 725797 726042 NADH dehydrogenase [ubiquinone] flavoprotein 1, mitochondrial; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 5, mitochondrial; ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; succinate dehydrogenase cytochrome b560 subunit, mitochondrial; putative ATP synthase subunit f, mitochondrial; cytochrome b-c1 complex subunit Rieske, mitochondrial; NADH dehydrogenase [ubiquinone] iron-sulfur protein 3, mitochondrial; NADH dehydrogenase [ubiquinone] iron-sulfur protein 6, mitochondrial; cytochrome c oxidase subunit 4 isoform 1, mitochondrial; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 5; cytochrome c1, heme protein, mitochondrial; NADH-quinone oxidoreductase subunit I; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 8, mitochondrial; cytochrome b-c1 complex subunit 7-like; ATP synthase subunit beta, mitochondrial; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 9, mitochondrial; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 10; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 11, mitochondrial; uncharacterized LOC725712; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 KEGG KEGG:01100 Metabolic pathways 27/29 321/1081 3.135353 0.0000000 0.0000000 0.0000000 408367 408477 409114 409236 409299 409473 409549 409930 411183 411411 412328 412396 413014 413605 551078 551660 551757 551766 551866 552424 552682 552699 724264 724719 725712 725797 726042 NADH dehydrogenase [ubiquinone] flavoprotein 1, mitochondrial; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 5, mitochondrial; ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; adenylosuccinate synthetase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; succinate dehydrogenase cytochrome b560 subunit, mitochondrial; putative ATP synthase subunit f, mitochondrial; cytochrome b-c1 complex subunit Rieske, mitochondrial; NADH dehydrogenase [ubiquinone] iron-sulfur protein 3, mitochondrial; NADH dehydrogenase [ubiquinone] iron-sulfur protein 6, mitochondrial; cytochrome c oxidase subunit 4 isoform 1, mitochondrial; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 5; cytochrome c1, heme protein, mitochondrial; NADH-quinone oxidoreductase subunit I; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 8, mitochondrial; cytochrome b-c1 complex subunit 7-like; ATP synthase subunit beta, mitochondrial; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 9, mitochondrial; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 10; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 11, mitochondrial; uncharacterized LOC725712; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Biological process GO:0017144 drug metabolic process 10/13 44/960 16.783217 0.0000000 0.0000000 0.0000000 409114 409236 409299 409473 409549 551757 551766 552682 552699 724264 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; adenylosuccinate synthetase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; succinate dehydrogenase cytochrome b560 subunit, mitochondrial; cytochrome b-c1 complex subunit 7-like; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like
Module 8 GO: Cellular component GO:0044429 mitochondrial part 10/24 38/1126 12.346491 0.0000000 0.0000000 0.0000000 406075 408270 409473 410022 413014 551325 551757 724264 725797 726042 ADP/ATP translocase; mitochondrial cytochrome C; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; mitochondrial-processing peptidase subunit beta; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 5; voltage-dependent anion-selective channel; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Biological process GO:0055086 nucleobase-containing small molecule metabolic process 9/13 52/960 12.781065 0.0000000 0.0000000 0.0000000 409114 409236 409299 409473 551757 551766 552682 552699 724264 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; adenylosuccinate synthetase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; cytochrome b-c1 complex subunit 7-like; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like
Module 8 GO: Cellular component GO:0070469 respiratory chain 6/24 8/1126 35.187500 0.0000000 0.0000000 0.0000000 408270 409473 409549 551757 725797 726042 mitochondrial cytochrome C; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; succinate dehydrogenase cytochrome b560 subunit, mitochondrial; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Biological process GO:0019637 organophosphate metabolic process 9/13 60/960 11.076923 0.0000000 0.0000000 0.0000000 409114 409236 409299 409473 551757 551766 552682 552699 724264 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; adenylosuccinate synthetase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; cytochrome b-c1 complex subunit 7-like; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like
Module 8 GO: Cellular component GO:0031967 organelle envelope 9/24 35/1126 12.064286 0.0000000 0.0000001 0.0000000 406075 408270 409473 413014 551325 551757 724264 725797 726042 ADP/ATP translocase; mitochondrial cytochrome C; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 5; voltage-dependent anion-selective channel; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Cellular component GO:0031975 envelope 9/24 35/1126 12.064286 0.0000000 0.0000001 0.0000000 406075 408270 409473 413014 551325 551757 724264 725797 726042 ADP/ATP translocase; mitochondrial cytochrome C; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 5; voltage-dependent anion-selective channel; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Biological process GO:1901135 carbohydrate derivative metabolic process 9/13 67/960 9.919633 0.0000000 0.0000001 0.0000000 409114 409236 409299 409473 551757 551766 552682 552699 724264 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; adenylosuccinate synthetase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; cytochrome b-c1 complex subunit 7-like; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like
Module 8 GO: Biological process GO:0022900 electron transport chain 5/13 9/960 41.025641 0.0000000 0.0000001 0.0000000 409473 413014 551757 724264 725797 NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 5; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3
Module 8 GO: Cellular component GO:0031966 mitochondrial membrane 8/24 28/1126 13.404762 0.0000000 0.0000001 0.0000001 406075 409473 413014 551325 551757 724264 725797 726042 ADP/ATP translocase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 5; voltage-dependent anion-selective channel; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Molecular function GO:0009055 electron transfer activity 5/22 8/1400 39.772727 0.0000000 0.0000005 0.0000002 408270 409549 412396 413605 726042 mitochondrial cytochrome C; succinate dehydrogenase cytochrome b560 subunit, mitochondrial; cytochrome c oxidase subunit 4 isoform 1, mitochondrial; cytochrome c1, heme protein, mitochondrial; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Biological process GO:0006793 phosphorus metabolic process 9/13 74/960 8.981289 0.0000000 0.0000001 0.0000000 409114 409236 409299 409473 551757 551766 552682 552699 724264 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; adenylosuccinate synthetase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; cytochrome b-c1 complex subunit 7-like; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like
Module 8 GO: Cellular component GO:0098803 respiratory chain complex 5/24 7/1126 33.511905 0.0000001 0.0000002 0.0000001 409473 409549 551757 725797 726042 NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; succinate dehydrogenase cytochrome b560 subunit, mitochondrial; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Biological process GO:0006091 generation of precursor metabolites and energy 6/13 21/960 21.098901 0.0000001 0.0000003 0.0000001 409473 409549 413014 551757 724264 725797 NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; succinate dehydrogenase cytochrome b560 subunit, mitochondrial; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 5; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3
Module 8 GO: Cellular component GO:0098796 membrane protein complex 9/24 46/1126 9.179348 0.0000001 0.0000004 0.0000002 409114 409473 409549 551757 551766 552682 552699 725797 726042 ATP synthase subunit alpha, mitochondrial; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; succinate dehydrogenase cytochrome b560 subunit, mitochondrial; cytochrome b-c1 complex subunit 7-like; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Molecular function GO:0016651 oxidoreductase activity, acting on NAD(P)H 5/22 10/1400 31.818182 0.0000001 0.0000008 0.0000007 411411 413014 551078 551660 724264 NADH dehydrogenase [ubiquinone] iron-sulfur protein 3, mitochondrial; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 5; NADH-quinone oxidoreductase subunit I; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 8, mitochondrial; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like
Module 8 GO: Molecular function GO:0015318 inorganic molecular entity transmembrane transporter activity 8/22 46/1400 11.067194 0.0000002 0.0000008 0.0000008 409114 409236 412396 551325 551766 552682 552699 726042 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; cytochrome c oxidase subunit 4 isoform 1, mitochondrial; voltage-dependent anion-selective channel; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Molecular function GO:0015075 ion transmembrane transporter activity 8/22 47/1400 10.831722 0.0000002 0.0000008 0.0000008 409114 409236 412396 551325 551766 552682 552699 726042 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; cytochrome c oxidase subunit 4 isoform 1, mitochondrial; voltage-dependent anion-selective channel; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Cellular component GO:0019866 organelle inner membrane 7/24 24/1126 13.684028 0.0000002 0.0000006 0.0000003 406075 409473 413014 551757 724264 725797 726042 ADP/ATP translocase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 5; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Cellular component GO:0045259 proton-transporting ATP synthase complex 4/24 5/1126 37.533333 0.0000008 0.0000021 0.0000010 409114 551766 552682 552699 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1
Module 8 GO: Biological process GO:0015980 energy derivation by oxidation of organic compounds 5/13 17/960 21.719457 0.0000011 0.0000033 0.0000009 409473 409549 413014 551757 724264 NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; succinate dehydrogenase cytochrome b560 subunit, mitochondrial; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 5; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like
Module 8 GO: Cellular component GO:0005746 mitochondrial respiratory chain 4/24 6/1126 31.277778 0.0000023 0.0000056 0.0000026 409473 551757 725797 726042 NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Cellular component GO:0033178 proton-transporting two-sector ATPase complex, catalytic domain 4/24 7/1126 26.809524 0.0000053 0.0000107 0.0000053 409114 551766 552682 552699 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1
Module 8 GO: Cellular component GO:0098800 inner mitochondrial membrane protein complex 4/24 7/1126 26.809524 0.0000053 0.0000107 0.0000053 409473 551757 725797 726042 NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Molecular function GO:0022804 active transmembrane transporter activity 5/22 19/1400 16.746412 0.0000060 0.0000203 0.0000146 409114 409236 551766 552682 552699 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1
Module 8 GO: Cellular component GO:0031090 organelle membrane 8/24 55/1126 6.824242 0.0000078 0.0000144 0.0000072 406075 409473 413014 551325 551757 724264 725797 726042 ADP/ATP translocase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 5; voltage-dependent anion-selective channel; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Cellular component GO:1990204 oxidoreductase complex 4/24 8/1126 23.458333 0.0000105 0.0000181 0.0000092 409473 409549 551757 725797 NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; succinate dehydrogenase cytochrome b560 subunit, mitochondrial; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3
Module 8 GO: Cellular component GO:0016469 proton-transporting two-sector ATPase complex 4/24 12/1126 15.638889 0.0000704 0.0001056 0.0000556 409114 551766 552682 552699 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1
Module 8 GO: Cellular component GO:0044455 mitochondrial membrane part 4/24 12/1126 15.638889 0.0000704 0.0001056 0.0000556 409473 551757 725797 726042 NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Biological process GO:1901564 organonitrogen compound metabolic process 10/13 271/960 2.724950 0.0003445 0.0009187 0.0002497 409114 409236 409299 409473 410022 551757 551766 552682 552699 724264 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; adenylosuccinate synthetase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; mitochondrial-processing peptidase subunit beta; cytochrome b-c1 complex subunit 7-like; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like
Module 8 GO: Cellular component GO:0044444 cytoplasmic part 11/24 214/1126 2.411604 0.0022229 0.0031383 0.0016714 406075 408270 409473 410022 413014 551325 551660 551757 724264 725797 726042 ADP/ATP translocase; mitochondrial cytochrome C; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; mitochondrial-processing peptidase subunit beta; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 5; voltage-dependent anion-selective channel; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 8, mitochondrial; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Biological process GO:0006139 nucleobase-containing compound metabolic process 9/13 285/960 2.331984 0.0035080 0.0084193 0.0024618 409114 409236 409299 409473 551757 551766 552682 552699 724264 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; adenylosuccinate synthetase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; cytochrome b-c1 complex subunit 7-like; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like
Module 8 GO: Biological process GO:0046483 heterocycle metabolic process 9/13 295/960 2.252934 0.0045674 0.0095806 0.0031066 409114 409236 409299 409473 551757 551766 552682 552699 724264 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; adenylosuccinate synthetase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; cytochrome b-c1 complex subunit 7-like; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like
Module 8 GO: Biological process GO:0006725 cellular aromatic compound metabolic process 9/13 297/960 2.237762 0.0048084 0.0095806 0.0032209 409114 409236 409299 409473 551757 551766 552682 552699 724264 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; adenylosuccinate synthetase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; cytochrome b-c1 complex subunit 7-like; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like
Module 8 GO: Biological process GO:1901360 organic cyclic compound metabolic process 9/13 300/960 2.215385 0.0051895 0.0095806 0.0033740 409114 409236 409299 409473 551757 551766 552682 552699 724264 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; adenylosuccinate synthetase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; cytochrome b-c1 complex subunit 7-like; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like
Module 8 GO: Molecular function GO:0020037 heme binding 2/22 9/1400 14.141414 0.0079419 0.0192875 0.0163854 408270 413605 mitochondrial cytochrome C; cytochrome c1, heme protein, mitochondrial
Module 8 GO: Molecular function GO:0046906 tetrapyrrole binding 2/22 9/1400 14.141414 0.0079419 0.0192875 0.0163854 408270 413605 mitochondrial cytochrome C; cytochrome c1, heme protein, mitochondrial
Module 8 GO: Biological process GO:0006810 transport 6/13 149/960 2.973671 0.0084648 0.0145111 0.0051977 409114 409236 410022 551766 552682 552699 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; mitochondrial-processing peptidase subunit beta; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1
Module 8 GO: Cellular component GO:0044446 intracellular organelle part 10/24 225/1126 2.085185 0.0116915 0.0155886 0.0083910 406075 408270 409473 410022 413014 551325 551757 724264 725797 726042 ADP/ATP translocase; mitochondrial cytochrome C; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; mitochondrial-processing peptidase subunit beta; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 5; voltage-dependent anion-selective channel; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Cellular component GO:0005737 cytoplasm 12/24 309/1126 1.822007 0.0146548 0.0185113 0.0096413 406075 408270 409299 409473 410022 413014 551325 551660 551757 724264 725797 726042 ADP/ATP translocase; mitochondrial cytochrome C; adenylosuccinate synthetase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; mitochondrial-processing peptidase subunit beta; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 5; voltage-dependent anion-selective channel; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 8, mitochondrial; cytochrome b-c1 complex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like; NADH dehydrogenase [ubiquinone] 1 beta subcomplex subunit 3; cytochrome c oxidase subunit 6A1, mitochondrial
Module 8 GO: Molecular function GO:0016817 hydrolase activity, acting on acid anhydrides 5/22 107/1400 2.973662 0.0218747 0.0464837 0.0389059 409114 409236 551766 552682 552699 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1
Module 8 GO: Biological process GO:0034641 cellular nitrogen compound metabolic process 9/13 368/960 1.806020 0.0231719 0.0370750 0.0136592 409114 409236 409299 409473 551757 551766 552682 552699 724264 ATP synthase subunit alpha, mitochondrial; ATP synthase subunit O, mitochondrial; adenylosuccinate synthetase; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 8; cytochrome b-c1 complex subunit 7-like; ATP synthase subunit beta, mitochondrial; ATP synthase, H+ transporting, mitochondrial F1 complex, delta subunit; ATP synthase, H+ transporting, mitochondrial F1 complex, gamma polypeptide 1; NADH dehydrogenase [ubiquinone] 1 alpha subcomplex subunit 7-like
Module 9 GO: Molecular function GO:0020037 heme binding 2/17 9/1400 18.300654 0.0047547 0.0523021 0.0725722 408879 551179 soluble guanylyl cyclase alpha 1 subunit; methyl farnesoate epoxidase
Module 9 GO: Molecular function GO:0046906 tetrapyrrole binding 2/17 9/1400 18.300654 0.0047547 0.0523021 0.0725722 408879 551179 soluble guanylyl cyclase alpha 1 subunit; methyl farnesoate epoxidase
Module 9 GO: Biological process GO:0035556 intracellular signal transduction 3/12 54/960 4.444444 0.0257948 0.6240421 0.8680508 408879 411134 724571 soluble guanylyl cyclase alpha 1 subunit; cdc42 homolog; atrial natriuretic peptide receptor 1
Module 9 GO: Molecular function GO:0004672 protein kinase activity 3/17 57/1400 4.334365 0.0289984 0.1770952 0.3276403 408325 409908 724571 cyclin-dependent kinase 5; tyrosine-protein kinase CSK; atrial natriuretic peptide receptor 1
Module 9 GO: Molecular function GO:0016772 transferase activity, transferring phosphorus-containing groups 4/17 104/1400 3.167421 0.0321991 0.1770952 0.3276403 408325 409908 411191 724571 cyclin-dependent kinase 5; tyrosine-protein kinase CSK; DNA-directed RNA polymerase III subunit RPC8; atrial natriuretic peptide receptor 1
Module 9 KEGG KEGG:00230 Purine metabolism 2/10 35/1081 6.177143 0.0389432 0.1525425 0.1605711 408879 724571 soluble guanylyl cyclase alpha 1 subunit; atrial natriuretic peptide receptor 1

Inspect the gene list for each module

This section lists all the genes in each module, their within-module connectivity values, and their fold-change in expression in response to queen pheromone in each of the four species.

Module 0

Table S25: List of all the genes in Module 0, ranked by their within-module connectivity, \(k\). The latter four columns give the Log\(_2\) fold-change in expression in response to queen pheromone in each of the four species.

module_gene_list <- function(module){
  inspect.module.genes(module) %>% 
  mutate(am_fc = log2(am_fc), bt_fc = log2(bt_fc), lf_fc = log2(lf_fc), ln_fc = log2(ln_fc)) %>% 
  rename(Gene = gene, Name = name) 
}
gene_list <- module_gene_list(0)
saveRDS(gene_list, file = "supplement/tab_S25.rds")
kable.table(gene_list)
Gene Name k am_fc bt_fc lf_fc ln_fc
GB40730 odorant receptor 2 0.6572887 0.5427109 -0.1048169 1.0856981 -0.2756124
GB52877 uncharacterized protein LOC726699 isoform X2 0.5852105 -0.5960765 -0.1117507 0.2453807 -0.4518517
GB55921 esterase FE4-like 0.5261953 -0.0722254 -0.2349972 0.8469903 -0.1497396
GB42205 uncharacterized protein LOC724413 0.5102071 0.4571923 0.0927301 0.2587316 -0.1252817
GB55743 WD repeat-containing protein 78-like isoform X2 0.4763912 -0.1199448 1.3331501 1.6458692 -0.3359528
GB43902 hexaprenyldihydroxybenzoate methyltransferase, mitochondrial-like 0.4071128 -0.0658685 -0.0051531 7.5139785 -0.3675137
GB54281 cAMP-dependent protein kinase type II regulatory subunit isoform X2 0.3984861 0.0156292 0.0166301 0.1711831 0.1568573
GB43306 uncharacterized protein LOC100188904 0.3906286 -0.7930497 -0.2279818 0.9211482 -0.2428097
GB49904 bone morphogenetic protein 5-like 0.3796728 -0.7719506 0.1965885 0.6831029 -0.4370223
GB45633 uncharacterized protein LOC726990 isoform X2 0.3491918 0.7900076 0.1584704 0.3204690 0.0643546
GB48685 endothelin-converting enzyme-like 1-like isoform X1 0.3481051 0.3143372 0.0999660 0.8622472 0.0663038
GB45358 nuclear cap-binding protein subunit 2-like 0.3468174 0.1324857 0.0623586 -0.1019064 -0.0363395
GB49297 protein eyes shut-like isoform X2 0.3338019 -0.2293376 -0.3155763 1.5346353 0.0553072
GB51851 diphthamide biosynthesis protein 7-like isoform X1 0.3151622 -0.3917106 -0.1136680 -0.3304302 -0.0659559
GB48100 forkhead box protein K2-like 0.3078646 0.0502399 -0.2868773 0.3823825 -0.1059860
GB53410 nicotinamide riboside kinase 0.3072171 -0.0247020 0.0214844 1.5120289 -0.0349848
GB52361 odorant receptor 2a 0.3069290 -2.2749522 0.3537685 0.6507751 -0.4687087
GB49771 probable U3 small nucleolar RNA-associated protein 11-like isoform X1 0.3061378 0.0854558 -0.0225643 3.6288168 0.0303111
GB54350 spermatogenesis-associated protein 6-like isoform X2 0.3017750 -0.2294756 0.1341991 0.2227130 0.3339552
GB52326 chemosensory protein 4 precursor 0.2774397 0.5027632 0.1834889 0.3130338 0.0521976
100576247 frizzled-2-like, transcript variant X8 0.2713537 0.1589072 -0.0487332 -0.4928034 0.1490305
GB41772 heterochromatin protein 1-binding protein 3-like 0.2688293 -0.1073461 -0.4365284 0.6386331 -0.2152302
GB46956 homeobox protein B-H2-like 0.2667862 0.0169211 0.0965548 0.9695841 -0.3526284
GB44120 venom serine protease 34 isoform X2 0.2582506 0.7919654 0.2284436 0.2714301 0.1146043
GB47515 homeobox protein unplugged-like 0.2533856 -1.1508447 1.3223466 1.1131006 0.3932851
GB52687 GATA zinc finger domain-containing protein 4-like 0.2478425 0.0848076 -0.0351808 0.4253072 -0.0704064
GB54180 segmentation protein paired 0.2464985 -0.3224775 -0.0046032 0.3908382 -0.0612394
GB17991 tyramine receptor 0.2376049 -0.4277596 0.1724761 0.1184470 0.3007527
GB43643 hepatic leukemia factor isoform X5 0.2300630 -0.0885873 -0.1806186 0.2619034 -0.4952980
GB45986 scavenger receptor class B member 1 0.2281921 0.7366095 0.2183160 0.3183776 0.4549123
100578193 uncharacterized protein LOC100578193 0.2265914 -0.3755927 0.3792736 0.1916142 -0.4536718
726803 uncharacterized protein LOC726803 0.2215070 0.6745736 -0.3232437 -1.6983735 0.2396084
GB52620 paired box pox-meso protein isoform X1 0.2179205 0.3464557 0.5825832 0.4101937 0.0852373
GB49410 calmodulin-like 0.2135726 -0.0277908 -0.0076846 -1.4889160 0.3165611
GB51295 homeotic protein Sex combs reduced 0.1994333 -0.4054444 0.0757676 0.7076951 -0.2371060
GB49332 brain-specific homeobox protein homolog 0.1988772 0.7829426 0.0740177 -0.0048292 -0.3017339
GB40967 tyrosine hydroxylase 0.1939191 0.2116776 0.0827130 0.0128425 -0.1121341
GB53374 connectin isoform X2 0.1923983 -0.4937854 0.0595257 -0.3398432 -0.6476856
GB49973 tachykinin-like peptides receptor 99D-like isoformX1 0.1903466 0.0684191 -0.3541607 0.4937453 -0.0304650
GB42531 zinc finger protein 470-like 0.1840118 -0.1266577 0.0929583 0.2507751 0.8348252
GB52394 odorant receptor 35 0.1836293 0.6743817 -0.8881546 1.7333684 0.2586459
GB40567 serine protease nudel 0.1791326 -0.1805806 0.1324198 -0.3540746 -1.0144147
GB47274 UNC93-like protein-like 0.1760126 0.0978842 0.0466488 0.2779259 0.0258282
100216325 extra macrochaetae 0.1721024 0.5375415 -0.2121133 0.5896375 0.0534075
GB40377 uncharacterized protein LOC551717 0.1713617 -0.4389868 0.3211403 0.5178133 -0.5558815
100576903 leucine-rich repeat-containing protein 15-like isoform 1 0.1676889 -0.1640799 -0.2865305 0.2111664 -0.5339650
GB50585 alpha-2 adrenergic receptor-like 0.1639323 -1.3390923 0.1074478 0.4529004 0.3822319
GB44017 uncharacterized protein LOC411209 isoform X2 0.1625509 0.1474582 0.1569075 0.7036695 0.1786378
GB40864 titin-like 0.1586610 -0.2709110 0.1674224 0.3516364 -0.5567276
GB51441 chromatin modification-related protein eaf-1-like isoform X1 0.1571053 0.1619194 -0.0375848 0.2031531 -0.3807868
GB55297 group XV phospholipase A2-like isoform X2 0.1568035 -0.2536120 0.0416420 0.1940768 0.4299899
GB42892 uncharacterized protein LOC100578699 0.1562923 -0.6872325 0.4138262 -0.1097415 0.0715533
102654715 general transcriptional corepressor trfA-like isoform X2 0.1559084 0.0078370 0.1479266 1.0733358 -0.0399459
GB55712 oocyte zinc finger protein XlCOF6-like isoform 2 0.1480120 0.0952047 0.3215760 -0.0374521 0.0247857
GB50761 chymotrypsin-1 0.1463405 1.0532771 0.3003517 -0.1385155 -0.3724792
GB54775 atrial natriuretic peptide-converting enzyme isoform X2 0.1460786 0.3743285 -0.1566519 -0.1456176 -0.5334649
102655422 uncharacterized protein LOC102655422 0.1385890 -1.2954113 0.0707611 1.0059718 -0.4904330
GB54401 elongation of very long chain fatty acids protein AAEL008004-like isoform X2 0.1336157 2.0899989 -0.4185501 0.4709814 0.4028595
GB51583 kynurenine/alpha-aminoadipate aminotransferase, mitochondrial-like 0.1294201 -0.3657577 -0.6117130 1.1668740 -0.3777787
726761 paired box protein Pax-2a-like isoform X2 0.1186476 0.0952047 0.1039544 0.5798076 -0.3699653
GB54748 proteasome activator complex subunit 3-like 0.1176236 0.7497801 -0.0323915 0.7625122 0.0351167
GB47018 uncharacterized protein LOC724886 0.1157315 -0.0164156 -0.1022657 0.3806585 -0.4249262
410557 ATP synthase subunit d, mitochondrial 0.1155345 -0.2801539 -0.1446580 -0.1014718 0.1167322
GB52755 SET and MYND domain-containing protein 4-like isoform X1 0.1144706 -0.4612234 -0.0706732 0.1929210 0.2102913
551397 28S ribosomal protein S18a, mitochondrial isoform 2 0.1106191 0.0893239 -0.0348236 5.0438999 0.0649919
GB54292 carbohydrate sulfotransferase 11-like 0.1081089 0.6020144 -0.1814898 0.0012975 -0.7088836
GB54802 N-acetyllactosaminide beta-1,3-N-acetylglucosaminyltransferase-like isoform X4 0.1010411 -0.0949371 -0.0202266 0.2535593 -0.1119863
GB45977 U11/U12 small nuclear ribonucleoprotein 25 kDa protein-like 0.0973792 -0.4071996 0.1883420 0.2946818 -0.0274482
GB44425 coiled-coil domain-containing protein 104-like 0.0950017 1.0012791 -0.6552046 0.3222395 -0.0112120
GB42296 peroxidase 0.0944093 0.2603950 0.0552470 0.4341475 -0.0883325
GB49261 uncharacterized protein LOC100576662 isoform X2 0.0939561 1.3148706 -1.9023012 0.2238545 0.4933903
GB40112 uncharacterized protein LOC410462 0.0937457 0.1315488 -0.1097024 1.2184136 0.0064863
102655945 uncharacterized protein LOC102655945 0.0853910 1.0611690 -0.0563931 0.0567426 0.4176833
GB51846 intraflagellar transport protein 46 homolog 0.0853640 0.3026173 0.0688653 0.3690897 -0.2026186
GB41946 cuticular protein analogous to peritrophins 3-D precursor 0.0841994 -0.4322829 -0.1502015 -0.1321769 -0.3638915
GB52186 trypsin-1 0.0834781 0.3099989 -0.0670718 0.9004645 -0.5621062
725247 probable inactive tRNA-specific adenosine deaminase-like protein 3-like 0.0818763 0.0520746 -0.0119089 -0.1750042 -0.0845647
GB43690 uncharacterized protein LOC727344 0.0773947 0.9254829 0.6988270 -0.1254874 0.7329609
GB51582 aristaless-related homeobox protein isoform X1 0.0773385 -0.7719506 0.1139744 0.0480020 -0.5857722
GB50650 flocculation protein FLO11 isoform X3 0.0750604 -0.4506516 0.3168894 0.2936290 -0.3835473
GB53126 polypeptide N-acetylgalactosaminyltransferase 2-like isoform X1 0.0728786 -0.1874685 -0.0755599 0.0117675 0.2530391
GB52465 vitellogenin-2-like 0.0706391 -0.3641471 -0.1829294 0.2532913 0.0637854
102656830 uncharacterized protein LOC102656830 0.0694468 -0.5795231 0.5620427 -0.7711959 0.5290816
GB55389 spondin-1 isoform X1 0.0687016 -0.1069032 0.0916424 -0.2983582 -0.0318121
100579019 probable salivary secreted peptide-like 0.0678622 1.3173295 0.3806096 0.9657867 0.7246295
GB48935 protein Star-like 0.0656996 0.5328535 0.2258289 -0.0290119 0.0975799
GB45062 protein apterous isoform X1 0.0635572 -0.0040100 0.0667620 0.4329189 -0.2189822
GB51622 heterogeneous nuclear ribonucleoprotein L isoform X1 0.0620070 -0.3556979 -0.0250075 0.0519768 0.1563677
GB48039 etoposide-induced protein 2.4-like isoform X2 0.0593876 0.1480499 0.0420642 0.3083053 0.0481981
GB45218 uncharacterized protein LOC408317 isoform 1 0.0590129 -0.0701274 0.2031972 0.1401007 0.0130554
GB55286 homeobox protein SIX2 0.0564249 0.5427109 0.2187393 -0.1002144 0.1124427
GB41714 uncharacterized protein LOC727150 isoform X2 0.0536204 -0.3826573 -0.2948150 -0.6827824 0.1802347
GB48943 isocitrate dehydrogenase [NAD] subunit beta, mitochondrial-like 0.0531532 -0.2625487 -0.3243812 -1.0083422 0.1533136
GB42736 TM2 domain-containing protein CG10795-like 0.0475663 0.5878244 0.0138815 0.3694662 0.3497229
GB46213 histone RNA hairpin-binding protein 0.0454788 0.0631496 0.0987922 0.0075179 0.3001147
GB42548 protein kinase C-binding protein NELL1-like isoform X1 0.0434579 0.4743526 0.1943156 0.2260726 -0.2723703
GB46050 protein king tubby-like 0.0415573 -0.0634324 -0.0908351 0.0621844 -0.0344164
GB47259 transcription initiation factor TFIID subunit 12 isoform X1 0.0382926 0.2916048 0.0603800 0.5179683 0.1507893
GB50014 coiled-coil domain-containing protein 111-like isoform X1 0.0375379 -0.3719751 0.0627743 -0.0525852 0.1564669
725329 UPF0489 protein C5orf22 homolog isoform X3 0.0367872 0.3150846 -0.0606647 0.0931977 0.1365816
725238 histone H1B-like 0.0309072 0.2753450 0.3068135 0.1248635 -0.0022862
GB46620 uncharacterized protein C1orf112 homolog 0.0276996 0.1393356 0.4834200 0.2695531 0.1281171
GB43867 uncharacterized protein PFB0765w-like 0.0266379 0.4678793 0.3258482 -0.0865333 0.0282067
724536 uncharacterized protein LOC724536 0.0208600 0.3961154 0.1620852 0.9048472 -0.2689525
GB52644 ATP synthase-coupling factor 6, mitochondrial 0.0189552 -0.1516881 -0.2233460 -0.0524388 0.2050755
GB55014 ras-related protein Rab-2-like 0.0129896 0.3709669 -0.0457940 0.5439276 0.0646793
GB41419 zinc finger protein 813-like 0.0088166 -0.4891554 0.0525762 0.3128437 0.0919048

Module 1

Table S26: List of all the genes in Module 1, ranked by their within-module connectivity, \(k\). The latter four columns give the Log\(_2\) fold-change in expression in response to queen pheromone in each of the four species.

gene_list <- module_gene_list(1)
saveRDS(gene_list, file = "supplement/tab_S26.rds")
kable.table(gene_list)
Gene Name k am_fc bt_fc lf_fc ln_fc
GB55823 tRNA-splicing ligase RtcB homolog 288.60578 -0.0281965 0.1606359 0.0394358 -0.0097862
GB44900 cullin-3 isoform X1 285.79810 -0.0382861 -0.0047554 -0.0087679 -0.0167811
GB54956 autophagy 1 283.90121 0.0479416 -0.0109422 -0.0038436 0.0293035
GB43113 serrate RNA effector molecule homolog isoform X1 274.93350 -0.1828134 0.0298681 0.0456132 0.0070646
GB45829 vacuolar protein sorting-associated protein 4B isoformX1 272.20072 0.0626642 0.0262989 0.0405129 0.0741006
GB47683 LOW QUALITY PROTEIN: vacuolar protein sorting-associated protein 8 homolog 271.82252 -0.2813646 0.0640363 0.0200654 0.0620023
GB41448 rho GTPase-activating protein 26-like isoform X5 269.98626 -0.1561438 -0.0326420 0.0587879 0.0755708
725575 axoneme-associated protein mst101(2)-like 266.56485 -0.2083017 0.0943316 -0.0364053 0.0898112
GB55512 acidic fibroblast growth factor intracellular-binding protein isoform X1 264.66218 -0.0103658 0.0249359 0.0105880 -0.4332690
GB43200 tRNA (uracil-5-)-methyltransferase homolog A-like isoform X2 262.81057 -0.1802649 -0.0730565 0.0004482 0.0794535
GB43952 nitric oxide synthase-interacting protein homolog 259.86949 -0.1106611 0.1507171 -0.2252511 0.0999624
GB45823 pre-mRNA-processing-splicing factor 8-like 256.62337 -0.0275978 0.0254559 0.0229017 -0.0415693
GB44359 leucine-rich repeat-containing protein 16A-like isoform X4 251.88726 -0.2150325 0.0201149 0.0425199 0.0791204
GB53699 survival of motor neuron-related-splicing factor 30-like isoform 2 250.81489 -0.0532802 0.0106550 -0.0371729 0.0489593
GB44682 catalase isoform 1 247.56249 -0.2115596 -0.0198514 0.0507368 -0.0195449
GB52979 dentin sialophosphoprotein-like isoform X1 242.91001 -0.1303534 -0.0578291 0.0289106 -0.0401034
GB47599 cytoplasmic dynein 1 light intermediate chain 1 isoform X2 242.47117 -0.3757009 0.0127303 0.0578175 0.0349926
GB44573 ubiquitin carboxyl-terminal hydrolase 5-like 241.46237 0.1447257 0.0672273 -0.0857979 0.0598318
GB50370 histone-lysine N-methyltransferase SETD1B-like isoform 1 240.88326 -0.1331707 0.1015549 0.6914511 0.0565033
GB41911 procollagen-lysine,2-oxoglutarate 5-dioxygenase 3-like isoform X1 240.26407 -0.1112528 0.0986711 0.0288154 0.4948914
GB44594 tyrosine-protein kinase hopscotch isoform X2 240.01837 -0.1512548 0.0282488 -0.0757608 0.0199088
GB49111 neuropathy target esterase sws isoform X3 239.64807 -0.0757516 -0.0047253 -0.0095098 0.2978976
GB52662 probable actin-related protein 2/3 complex subunit 2 isoform 2 237.85199 -0.0906784 0.0390845 0.0221270 0.0512174
GB48925 superkiller viralicidic activity 2-like 2-like isoform X2 234.51059 -0.1250507 0.0268830 0.0365259 -0.0074083
GB50757 KH domain-containing, RNA-binding, signal transduction-associated protein 3-like isoformX2 232.04054 -0.1457952 -0.0727868 0.0413845 0.0402818
724928 tubulin-specific chaperone C-like isoform 1 232.01258 -0.0979867 0.0556192 -0.0244316 0.1072274
GB56004 ATPase family AAA domain-containing protein 1-A-like 229.97172 0.0491721 0.0287752 0.0581703 0.0437436
GB55941 hemK methyltransferase family member 1-like isoform X2 229.96678 -0.0639887 0.1344013 -0.0585299 0.0227723
GB53725 splicing factor 3B subunit 1-like isoform X2 227.26120 -0.3550024 -0.0844896 0.0817055 -0.0164484
GB49918 optineurin isoform X2 226.53292 -0.3600699 0.0370622 0.0476319 0.0622934
GB42141 probable medium-chain specific acyl-CoA dehydrogenase, mitochondrial-like 225.66044 0.6614338 -0.1489981 -0.0676639 0.1896882
GB49425 ATP-dependent zinc metalloprotease YME1 homolog isoform X3 225.13635 -0.4503013 0.1263263 0.0349089 0.0999659
GB44423 vacuolar fusion protein MON1 homolog A-like 224.89964 -0.0033257 -0.0179326 0.0422244 0.0122336
GB51133 uncharacterized protein LOC725950 isoform X7 224.34524 -0.2949259 -0.0250259 0.2953370 -0.0581774
GB49943 eukaryotic translation initiation factor 3 subunit D 223.69559 0.1541782 0.0548449 0.0315715 -0.0248784
GB43707 smallminded 223.35421 -0.5113509 0.0899614 0.0309637 0.0359696
GB43172 cyclin-dependent kinase 11B isoform X1 222.96837 -0.0206602 -0.0559101 -0.0643595 -0.0510414
GB47089 BRCA1-A complex subunit Abraxas-like isoform X2 222.94741 -0.0656233 0.2064747 0.0365300 0.0739280
GB47208 mitogen-activated protein kinase kinase kinase 10 isoform X4 221.51290 -0.1552847 0.0183887 0.0324778 -0.0443445
GB48347 WASH complex subunit strumpellin-like isoform X3 220.70903 -0.3686723 0.1050430 -0.0075903 0.0235721
GB44556 uncharacterized protein LOC411962 isoform X2 220.16678 -0.1133288 0.1546915 0.0027307 0.0339605
GB50854 AP-1 complex subunit beta-1 219.38155 -0.1349754 -0.0211709 -0.0270254 -0.0266302
GB55540 zinc finger MYM-type protein 3-like 219.30291 -0.0118923 -0.0201705 0.0769080 0.1084151
GB46636 probable exonuclease mut-7 homolog isoform X2 219.01449 -0.2838153 -0.1186433 0.0074181 0.0254409
GB40507 nucleolar protein 10 218.40981 -0.2600232 0.1445714 -0.0551367 0.1223630
GB54228 SUMO-activating enzyme subunit 2 isoform X1 217.33099 0.0566474 0.1842158 0.1083653 -0.0153830
GB54389 copper-transporting ATPase 1 isoform X2 217.11573 0.1360450 -0.0242164 0.0349226 -0.0757144
GB44516 exostasin 2, transcript variant X2 217.07220 -0.1341388 -0.1048453 0.0576125 0.0588822
GB41488 ankyrin repeat and LEM domain-containing protein 2-like isoform X4 216.31840 -0.3975618 0.0422519 0.0358214 0.1054610
GB50042 vesicular integral-membrane protein VIP36 215.91764 0.2931243 -0.0695297 0.5128282 0.0768173
GB47110 methylcrotonoyl-CoA carboxylase subunit alpha, mitochondrial-like 215.49170 -0.0366004 -0.0681734 -0.0549869 -0.7324760
GB49428 tuberin isoform X2 215.21096 -0.1966563 -0.0427339 0.0649788 0.0837811
GB51360 integrator complex subunit 1-like, transcript variant X2 214.63924 -0.0009533 -0.1018687 -0.0341014 0.0959737
GB45873 ubiquitin conjugation factor E4 A-like isoform X2 214.47969 -0.1298061 -0.0670541 -0.0187154 0.0912066
GB41024 U3 small nucleolar RNA-associated protein 6 homolog isoform X2 214.21983 -0.0754706 0.2934448 -0.0471835 -0.0133720
GB40711 RING finger protein 10-like 214.18339 -0.2255345 -0.0612001 0.0301634 0.0202273
GB50872 general transcription factor IIF subunit 2 isoformX1 213.92042 -0.1533262 0.1310806 0.0659204 0.0550357
GB42977 DNA polymerase delta catalytic subunit isoform X2 212.90650 -0.1488819 0.0865535 -0.0887230 0.0205718
GB54054 LOW QUALITY PROTEIN: ubiquitin carboxyl-terminal hydrolase 7 210.77828 0.0951204 0.0190603 0.0652836 -0.2480764
GB44421 replication protein A 70 kDa DNA-binding subunit isoform X2 210.01165 -0.2826954 0.0303812 -0.0334162 0.1465698
GB46511 protein bric-a-brac 2 isoform X1 209.84256 -0.2726323 0.2269248 0.1011703 0.1941534
GB46065 Hermansky-Pudlak syndrome 5 protein homolog isoform X1 208.51637 -0.3335396 -0.0692699 -0.0184378 -0.0121288
GB49749 uncharacterized protein C12orf4 homolog 208.43198 0.1077336 0.1128373 0.0514064 0.0328803
GB42159 uncharacterized exonuclease C637.09-like isoform X3 208.00661 -0.2291293 0.1394666 0.0405295 0.0173193
GB46431 eukaryotic translation initiation factor 3 subunit A 207.75211 -0.0484745 0.0738027 0.0359871 -0.0801569
GB42058 helicase SKI2W 207.73875 -0.3389229 0.0170163 0.0148386 -0.0011292
GB55476 oxysterol-binding protein-related protein 9-like isoform X4 207.60126 -0.1213446 0.0759970 0.0816787 -0.2342863
GB49296 zinc finger CCCH domain-containing protein 13-like 207.29654 -0.3953375 0.0585999 0.0106809 -0.0088986
GB42448 mediator of RNA polymerase II transcription subunit 15-like isoform X2 206.68794 -0.4547626 0.0176299 0.2826344 0.1883594
410869 vacuolar-sorting protein SNF8 isoform X1 206.50165 -0.1110148 0.0430158 0.0852174 0.1127796
GB50847 SWI/SNF-related matrix-associated actin-dependent regulator of chromatin subfamily E member 1-like 206.23119 -0.0544846 0.1186289 0.0439726 0.0072304
GB50287 RAD50-interacting protein 1-like isoform X1 205.39572 -0.2573657 -0.0043303 0.1784503 -0.0248772
GB50276 dual specificity mitogen-activated protein kinase kinase 4 205.10168 0.1950044 0.0493514 0.0517128 0.0333314
GB54194 charged multivesicular body protein 4b isoform X1 205.02779 0.0124217 0.0190265 -0.0035026 0.0848020
GB45008 angio-associated migratory cell protein-like isoform X2 204.58184 -0.0693296 0.0848315 -0.1822455 0.0321644
GB55459 general transcription factor IIH subunit 1 isoform X1 203.92803 -0.0564831 0.1354081 0.0792959 0.0339948
GB45683 WD repeat-containing protein 3-like 203.88116 -0.2248092 0.0414917 0.0189259 0.0605902
GB41025 chromobox protein homolog 5-like 203.64027 -0.3577102 -0.0611846 0.0556368 -0.2955834
GB51246 mediator of RNA polymerase II transcription subunit 23 isoform X2 203.42594 -0.0531331 -0.0438789 0.0418241 -0.0064390
GB54087 zinc finger FYVE domain-containing protein 19-like 203.27090 -0.1623556 -0.0450021 0.0891825 0.0966665
GB54425 cullin-associated NEDD8-dissociated protein 1-like isoform X2 202.73240 0.2014709 0.0849647 -0.0221812 0.0332585
GB41258 BTB/POZ domain-containing adapter for CUL3-mediated RhoA degradation protein 3-like 202.63989 -0.1244124 0.0601458 -0.0383048 0.0104664
GB51495 u4/U6.U5 tri-snRNP-associated protein 1-like, transcript variant X2 202.47328 -0.2072260 0.0624135 0.0445140 0.1140704
GB47575 tyrosine-protein phosphatase corkscrew isoform X4 202.14336 -0.0520171 -0.0686207 0.0453436 0.0411802
GB41293 histone acetyltransferase KAT8 isoform X1 201.80732 0.0731326 -0.0280351 0.4838555 0.0243201
GB54589 YTH domain family protein 3-like isoform X1 201.61658 -0.2767910 0.0481742 0.1163326 0.0103777
GB45114 HEAT repeat-containing protein 1 isoform X2 201.61325 -0.0382402 0.0857539 -0.3060003 0.0492955
GB44690 serine/threonine-protein phosphatase 4 regulatory subunit 3 isoform X2 200.87975 -0.0678411 0.2092908 0.0480516 0.1631517
GB50409 splicing factor 3A subunit 1 isoformX1 200.84030 -0.2564942 0.1671163 -0.0032251 -0.0553593
GB43192 transcription initiation factor TFIID subunit 6 isoform X2 200.83407 -0.0035335 -0.0810491 -0.0059793 -0.0502864
GB53829 CD2 antigen cytoplasmic tail-binding protein 2 homolog 200.78864 -0.2900452 0.0257855 -0.0384880 -0.0952961
GB44912 lethal(3)malignant brain tumor-like protein 3-like isoform X6 200.71246 -0.3218606 0.0963412 0.0702666 0.1880399
GB47102 general vesicular transport factor p115 200.22598 -0.2489558 0.0260273 -0.0391379 0.3523676
GB52559 LMBR1 domain-containing protein 2 homolog 199.81537 0.0894252 -0.0682850 0.0421673 0.0129771
GB43122 probable RNA-binding protein 19-like isoform X2 199.50308 0.1037877 0.0254709 0.0230659 0.0584319
GB46972 vacuolar protein sorting-associated protein 52 homolog isoform 1 199.01673 -0.3521252 -0.0413197 -0.0537183 -0.0007593
GB40578 sodium/hydrogen exchanger 7 isoform X1 197.99334 0.1602845 -0.0597625 0.1297220 -0.0419840
GB55413 zinc transporter 9-like 197.33188 -0.1174266 0.0917137 0.0326560 0.0912740
GB51717 WASH complex subunit 7-like 196.82193 0.0976007 0.0871875 0.0488481 -0.1357646
GB51954 sec1 family domain-containing protein 2-like isoform X2 196.77792 -0.1159123 -0.0372640 0.0298109 0.0810476
GB47680 TATA-binding protein-associated factor 172-like isoform X2 196.59706 -0.2510289 0.0557936 0.4483637 -0.2930443
GB52641 glyoxalase domain-containing protein 4-like 196.56385 -0.4062763 0.0783375 0.0006743 0.0573930
GB48101 importin-4-like 196.49388 0.3244796 0.1313727 0.6063033 0.0647293
GB49047 26S protease regulatory subunit 6A 196.44539 0.1870912 -0.0769411 -0.0688529 0.0124138
GB54045 ras-related protein Rab-40C-like isoform 2 196.44107 -0.0714702 -0.0392858 -0.0236941 0.0779570
GB40893 trafficking protein particle complex subunit 8-like isoform X3 196.40522 -0.4376881 0.0147667 -0.0150959 -0.2189324
100578159 zinc finger matrin-type protein CG9776-like isoform X4 196.30337 -0.2787936 -0.0067094 -0.1794822 0.6734605
GB47093 activator of basal transcription 1-like 196.00855 -0.2592536 0.0584833 -0.0210939 0.0941891
GB44486 tyrosine-protein phosphatase non-receptor type 21 isoform X2 195.67834 -0.0424408 -0.0279357 0.0603428 0.0516163
GB49468 RRP12-like protein-like isoform X2 195.37538 -0.3181060 0.0535266 0.0751676 -0.0371262
GB43565 OTU domain-containing protein 5-A-like 195.02494 0.1160859 0.1349821 0.0564931 0.0420354
GB53614 RNA-binding protein 26 isoform X2 195.00729 -0.0370210 0.0914187 0.0423985 0.0450740
GB54328 GDP-Man:Man(3)GlcNAc(2)-PP-Dol alpha-1,2-mannosyltransferase-like 194.81477 -0.2904883 -0.0153050 0.0555989 0.0358194
GB41239 trichohyalin 194.80269 -0.4969900 0.1078321 0.0416462 -0.0650865
GB41795 vacuolar protein sorting-associated protein 33B isoform X2 194.64502 0.0184606 -0.0756184 -0.0092399 0.0720473
GB54526 mitotic spindle assembly checkpoint protein MAD1 194.42503 -0.0968978 0.1590043 0.0563812 0.1427241
GB45184 2-hydroxyacyl-CoA lyase 1-like 194.01437 0.2399532 -0.1341564 -0.3798903 -0.0909855
GB40361 sister chromatid cohesion protein PDS5 homolog B-B-like isoform X1 193.12195 -0.2778751 0.0418388 -0.0040056 -0.0692047
GB54995 Rho-associated, coiled-coil containing protein kinase 2, transcript variant X2 193.00300 -0.2527626 -0.0531265 0.0774855 -0.0314964
GB50952 E3 ubiquitin-protein ligase RNF13-like isoform X2 192.53325 -0.0427018 -0.0506680 0.0632524 0.1139598
GB10936 U4/U6 small nuclear ribonucleoprotein Prp3 192.47652 -0.0832154 0.1059277 0.0392885 0.0493244
GB47660 alpha-1,3-mannosyl-glycoprotein 4-beta-N-acetylglucosaminyltransferase B-like isoform X3 192.16032 -0.0683519 0.0627941 0.0415849 0.1806669
GB40880 DDB1- and CUL4-associated factor-like 1-like isoform X1 191.99601 -0.1845890 0.0274321 0.0870227 0.0344227
GB49654 zinc finger protein 830-like 191.79217 -0.5377447 0.0510624 0.0420019 0.1165216
GB45214 zinc finger FYVE domain-containing protein 16 isoform X5 191.54102 -0.2169496 0.0410720 0.0791372 0.1653875
GB49409 tetratricopeptide repeat protein 7B-like, transcript variant X5 191.37636 -0.2374575 -0.0092338 0.0054186 0.0171132
GB43540 uncharacterized protein LOC552071 191.18104 -0.3225314 0.0399793 0.0517002 0.0871493
GB47904 26S protease regulatory subunit 7 191.16782 0.1931016 0.0261522 -0.0884919 -0.0216421
GB43124 uncharacterized protein C19orf47 homolog 190.69983 -0.1270242 0.0090097 -0.1110097 0.1137965
GB47888 bifunctional protein NCOAT-like isoform X2 190.61237 -0.1794708 0.0116590 -0.1209920 0.0551990
GB55056 spermatogenesis-associated protein 20 isoform X2 189.60767 -0.4202731 -0.1339388 0.2933127 0.0762342
GB55644 uncharacterized LOC409221, transcript variant X3 189.46212 0.0184559 0.0382613 0.0226602 0.0069678
410886 E3 ubiquitin-protein ligase UBR2-like 189.45383 -0.0657603 -0.1132438 0.1327208 0.0552951
GB54718 DNA repair protein REV1 188.92044 -0.1590842 0.0141426 0.1022615 0.1018506
GB46344 ubiquitin carboxyl-terminal hydrolase 8-like isoform X2 188.90772 0.1338219 0.0127657 0.0673908 0.2682462
GB49490 actin-like protein 87C-like 188.71480 0.2739357 0.0014613 0.0567098 0.1218011
GB40741 PAX-interacting protein 1-like 187.83922 -0.1494487 0.0936160 -0.1602269 0.0859703
GB45436 coiled-coil and C2 domain-containing protein 1-like isoform X2 187.64562 -0.2334624 -0.0042491 -0.3146303 0.1725393
GB40948 uncharacterized protein LOC412397 isoform X2 187.60150 -0.1195504 -0.1987567 0.0329359 -0.0120353
GB42841 very long-chain specific acyl-CoA dehydrogenase, mitochondrial-like 187.44986 0.1025917 -0.0557134 0.1898248 -0.2027086
726952 ER degradation-enhancing alpha-mannosidase-like 1 187.41257 -0.2617900 0.0639915 -0.0160886 -0.0295248
GB46070 protein SMG5-like 187.27829 -0.1229102 -0.0925536 0.3059350 -0.0315365
GB45452 AP-3 complex subunit mu-1-like isoform X1 187.04835 0.0655556 0.0255746 -0.0314282 -0.0108713
GB50607 grpE protein homolog 1, mitochondrial 187.03757 0.0096856 -0.0449069 -0.0250354 0.0850403
GB43637 protein asunder homolog 186.75665 0.2475874 0.1792277 -0.0441214 -0.0418747
GB50231 protein RMD5 homolog A-like 186.62899 0.3061106 -0.0209362 0.0333957 0.0617826
GB40744 squamous cell carcinoma antigen recognized by T-cells 3 186.59024 0.0031934 0.1430022 0.0765439 0.0040247
GB50945 dentin sialophosphoprotein-like 186.47581 -0.2403981 0.2168386 -0.0885244 -0.0121863
GB50067 charged multivesicular body protein 3 186.29749 0.0373942 -0.0392116 -0.0473283 0.0914076
GB51588 actin-related protein 2-like isoform X5 186.02492 -0.1207530 -0.0135926 0.0840078 0.0924636
GB47440 dynamin related protein 1 185.71493 0.3390192 0.1217222 0.0267123 0.0409860
GB42750 LOW QUALITY PROTEIN: PHD finger protein 14-like 185.70490 -0.0904365 0.1562576 0.0224898 0.1213014
GB42223 elongation factor G, mitochondrial-like 185.66155 -0.2882916 0.0108843 -0.0950271 0.7205432
GB42739 xanthine dehydrogenase isoform X4 185.64800 -0.1405292 -0.1027501 -0.0623907 0.0629294
GB48532 protein zer-1 homolog isoform X2 185.28231 -0.0308770 0.0162875 0.1010409 0.0689667
GB55550 ras GTPase-activating protein 1-like, transcript variant X3 185.04993 0.0439635 0.1644054 0.0821610 0.0309474
GB48631 probable complex I intermediate-associated protein 30, mitochondrial-like 184.95905 0.0568233 0.0176154 0.0873688 0.0771332
GB50083 pre-mRNA-splicing factor SPF27 isoform X1 184.87477 0.0208596 0.0744052 0.0270616 0.0235241
GB47333 probable glutamate–tRNA ligase, mitochondrial-like 184.87031 -0.3534262 0.0248370 -0.0073916 0.2747849
GB46028 E3 ubiquitin-protein ligase RNF14-like 184.64677 -0.4690063 0.0376000 1.1864935 0.2093782
GB43178 WD repeat-containing protein mio-B isoform X2 184.57653 0.0293342 0.0525459 0.0684298 0.0325748
GB41080 ubiquitin carboxyl-terminal hydrolase 14-like isoform 2 184.34094 0.1225644 -0.0941514 0.0362429 -0.0218409
GB45113 mitochondrial inner membrane protein OXA1L-like 182.83456 -0.3997153 -0.0529569 -0.0615654 -0.0646304
GB46026 mitochondrial import receptor subunit TOM70 182.74842 0.1008186 0.0267759 -0.1440612 0.0690353
GB42452 mediator of RNA polymerase II transcription subunit 27 182.52298 -0.2732879 0.1047517 0.1002314 0.1012910
GB51699 WD repeat-containing protein 43-like 182.24772 0.2668500 0.1496757 0.1169627 0.0528346
GB45739 2-oxoisovalerate dehydrogenase subunit alpha, mitochondrial-like isoform 1 182.21100 0.1174785 0.0235244 -0.0381293 -0.1973933
GB47420 nuclear RNA export factor 1-like isoform 2 182.07859 -0.3060885 0.0469920 0.0715271 0.1336460
GB46118 cerebellar degeneration-related protein 2-like isoform X1 181.50554 -0.1810810 0.1412101 0.1458258 -0.0011423
GB40466 ATP-binding cassette sub-family F member 2-like isoform X1 181.49253 -0.2929678 0.1022491 0.0135726 0.0676464
GB45345 zinc finger MYND domain-containing protein 11-like isoform X2 181.47460 -0.2657453 -0.0096304 0.0320374 -0.0016745
GB54780 protein brunelleschi-like isoform X2 181.36263 -0.0920858 0.0445131 0.0093270 -0.0018704
GB52883 FAM203 family protein GA19338-like 180.65742 -0.3794956 -0.0715496 0.0201639 0.0823561
GB52978 TBC1 domain family member 15 180.57903 -0.0698828 -0.0207859 0.0459486 0.1170165
GB48457 peptidylprolyl isomerase domain and WD repeat-containing protein 1 isoform X3 180.39663 -0.2662506 0.0330535 0.1503931 0.0980952
GB44048 endoplasmic reticulum lectin 1-like isoform X4 179.73712 0.2131686 0.0341315 -0.0493331 0.0383247
GB43448 calpain-B 179.65040 -0.1504593 -0.1893015 0.0950542 -0.0553624
GB49027 sulfide:quinone oxidoreductase, mitochondrial-like isoform X2 179.61486 -0.2412945 0.0622571 0.0283813 0.0150266
GB41713 TATA element modulatory factor-like isoform X2 179.52439 -0.5942016 -0.1334045 0.0817136 0.0338489
GB52536 LOW QUALITY PROTEIN: proteasome-associated protein ECM29 homolog 179.51337 -0.3709278 -0.1049523 0.0249237 0.0360125
GB47250 THO complex subunit 1-like isoform X2 179.50239 -0.4606453 -0.0355974 -0.0108644 0.1065647
GB46034 syntaxin-12 179.27246 -0.5643866 0.1050736 0.0595323 -0.0092484
GB46121 ubiquitin fusion degradation protein 1 homolog isoform X2 179.20842 0.1628130 -0.0690992 -0.0597555 0.0616813
GB45831 beta-parvin-like 179.06186 0.0981391 -0.0717356 0.0405107 0.0649034
GB55931 double-strand-break repair protein rad21 homolog isoform X1 178.51700 0.0934565 -0.0059451 0.1276780 0.0174615
GB51496 uncharacterized protein C17orf85 homolog 178.48117 -0.4429990 0.0208189 0.0856665 0.0212191
GB52628 heat shock factor protein isoform X3 178.38518 -0.4029739 -0.1067077 0.1281488 -0.0121320
GB46594 striatin-interacting proteins 2-like isoform X1 178.31577 -0.0522705 -0.0782125 -0.0809841 0.1447182
GB46074 survival motor neuron protein-like 178.23320 0.0318356 -0.1049528 -0.1251078 -0.0021880
GB47329 WD and tetratricopeptide repeats protein 1-like isoform X2 178.16797 -0.1775274 -0.0162210 0.0006628 0.1730579
GB42204 rho guanine nucleotide exchange factor 3-like 177.95959 -0.3994772 -0.0160166 -0.0599380 0.0209071
GB45868 F-box/WD repeat-containing protein 7 isoform X2 177.79490 -0.2331125 0.0752654 0.0799164 -0.1496531
GB48544 coiled-coil domain-containing protein 43-like 177.54881 -0.0017113 0.0318609 0.2139969 0.0935069
GB50345 probable phosphorylase b kinase regulatory subunit alpha-like isoform X4 177.04077 -0.1970543 -0.1368905 0.1315939 -0.0200568
GB49040 KAT8 regulatory NSL complex subunit 2 isoform X5 176.85922 0.0628656 0.0015017 0.0950085 0.1013152
GB50587 uncharacterized protein LOC410622 176.82342 -0.1294509 -0.0494395 0.0295796 0.0206181
GB43464 lysosomal Pro-X carboxypeptidase-like 176.81252 -0.0321209 -0.1409916 -0.0328756 -0.3729907
GB49651 exocyst complex component 3 176.78523 0.3444830 0.0335798 0.0782172 0.0560180
GB47161 pre-mRNA-splicing factor 18-like 176.68527 -0.3164830 -0.0414798 0.0783095 0.0497773
GB53617 sorting and assembly machinery component 50 homolog 176.58814 0.2471963 0.0396593 0.0600269 -0.0000683
GB44439 eukaryotic initiation factor 4A-III-like isoform 1 176.36635 0.2454471 0.0368400 0.0224123 0.1284649
GB55333 N-alpha-acetyltransferase 35, NatC auxiliary subunit isoform X2 176.32691 -0.2174214 -0.0214850 0.1622942 0.0288509
GB46061 RNA-binding protein 28-like 176.30769 -0.5296071 0.0384121 -0.0595057 0.1182992
GB41244 inositol polyphosphate 5-phosphatase K-like isoformX1 176.00550 0.4250308 -0.1333282 -0.3800855 0.0761223
GB52848 titin-like 175.91179 -0.7125301 -0.0077780 0.8302290 0.3280266
GB46036 periodic tryptophan protein 2 homolog 175.76898 -0.5643656 0.1320948 -0.0433318 0.0847922
GB50145 ubiquitin domain-containing protein 2-like 175.67101 -0.0961307 -0.0170959 -0.0665807 0.0997034
GB46927 F-box only protein 21-like 175.66482 -0.5308469 -0.0239916 0.6896461 0.8500469
GB51464 rho GTPase-activating protein 44-like isoform X2 175.50768 -0.0356736 0.0748345 -0.0162261 0.1120328
GB44172 protein CASC3-like isoform X2 175.36510 -0.2780037 0.0571639 0.1046004 0.0705342
GB46655 splicing factor U2AF 50 kDa subunit isoform X1 175.34594 0.2411086 0.0628230 -0.0157794 -0.0181715
GB49596 NEDD8-activating enzyme E1 catalytic subunit-like 175.33079 0.0017760 0.0725714 -0.0368334 0.0216606
GB49974 3-hydroxyisobutyryl-CoA hydrolase, mitochondrial-like isoform X1 175.25673 -0.3626690 0.0262583 0.0964368 -0.0016298
GB46211 zinc finger protein 665-like isoform X3 174.89780 -0.0371873 0.0919620 0.0388458 0.0879322
GB42525 zinc finger protein ZPR1 174.77262 -0.1756571 0.0799344 -0.1391161 0.0889572
GB49423 probable queuine tRNA-ribosyltransferase 174.76994 -0.0692681 -0.0473035 0.0835788 0.1350037
GB51806 coiled-coil domain-containing protein 93 isoform X2 174.66102 -0.0740182 -0.0777750 -0.0645862 0.2814372
GB45534 exocyst complex component 7 174.53202 -0.1691080 0.0860970 0.1086326 0.0380245
GB47192 exosome complex component MTR3-like isoform X2 174.45096 0.0893465 0.0284133 0.0095640 0.1473212
GB54583 H/ACA ribonucleoprotein complex non-core subunit NAF1-like 174.21282 -0.5948602 0.0305381 -0.0724988 -0.0478107
GB40858 probable ATP-dependent RNA helicase DDX47-like isoform 1 174.21195 -0.2341246 0.0555878 -1.0745571 0.0215981
GB44010 zinc finger protein 23-like isoform 1 174.09862 -0.4749669 0.2433766 -0.4748139 0.0548570
GB49244 charged multivesicular body protein 5-like 174.09745 0.2531362 0.0673163 0.0949334 0.0353168
GB46494 Golgi reassembly-stacking protein 2-like 174.00731 0.1043000 0.0783469 0.5963635 -0.0720191
GB40267 probable 39S ribosomal protein L45, mitochondrial 173.61348 -0.3108193 0.0808213 0.1174777 0.0445115
GB41968 protein max isoform 2 173.47923 0.1398838 -0.0192584 0.1033002 0.0411996
GB48170 ran GTPase-activating protein 1-like isoform X1 173.43099 -0.1000298 0.1880882 -0.0203595 0.1301734
GB52673 gamma-tubulin complex component 6-like isoform X1 173.25955 -0.3170258 0.1045833 0.0360074 0.1465033
GB49776 retinoblastoma-binding protein 5-like isoformX1 173.22991 -0.1295567 0.0659218 -0.0421685 0.0732333
GB41902 pre-rRNA-processing protein TSR1 homolog 173.17493 -0.2497342 0.1009075 0.0289703 0.0035600
GB40559 CDK5 regulatory subunit-associated protein 3-like 173.01764 -0.1834198 0.0129343 -0.0847038 -0.0949503
100576610 mitochondrial ribonuclease P protein 3-like 172.91161 -0.4591328 0.0643239 0.0235932 -0.0005263
GB40901 probable cleavage and polyadenylation specificity factor subunit 2 isoform X1 172.49223 -0.0634519 0.1359103 1.2895750 -0.0328744
GB44940 exosome complex exonuclease RRP44-like isoform X1 172.44818 -0.1231613 0.0184006 -0.0184116 0.0612947
GB50421 prosaposin isoformX1 172.35206 -0.1462134 -0.1051595 0.0445204 -0.1935779
GB50747 trafficking protein particle complex subunit 13-like 172.30048 -0.3015649 -0.0228584 0.0024468 0.1165972
GB43820 PHD finger and CXXC domain-containing protein CG17446-like isoform 1 172.08648 -0.4095687 -0.0038770 0.0133290 0.0896747
GB50846 vacuolar protein-sorting-associated protein 36 172.06052 -0.1934524 -0.0594418 0.0321774 0.0339590
GB54227 phosducin-like protein-like isoform 1 171.96010 -0.1002961 -0.1224734 0.0583757 0.1704157
GB48450 bobby sox, transcript variant X3 171.92532 -0.2119543 -0.0972506 0.0892759 0.0377658
GB45905 thyroid receptor-interacting protein 11 isoform X3 171.89349 -0.4200163 -0.1624605 0.0417834 -0.0689656
GB51462 methyltransferase-like protein 23-like isoform X2 171.63545 -0.6825529 0.0278093 0.4308139 0.0774094
GB43305 ubiquitin specific protease-like 171.46594 -0.0817327 -0.0471341 -0.0294597 0.0644272
GB43888 parafibromin 171.40017 0.0141943 0.1746474 -0.0095792 0.0361076
GB52977 UBX domain-containing protein 1-A-like 171.15919 -0.3004957 0.0598596 -0.0715498 0.2815663
GB54938 ATPase WRNIP1-like isoform X6 171.12996 -0.3365107 0.0025946 0.0240983 -0.1116194
GB42479 T-complex protein 1 subunit eta 171.02672 0.1927516 0.1401026 -0.0157018 -0.0150165
GB42447 WW domain-binding protein 11-like 170.59498 -0.0671181 0.0354914 0.0095909 0.0582653
GB41300 bystin isoform 1 170.47301 -0.0852244 0.0873668 -0.0515452 -0.0350653
GB44865 rab GTPase-binding effector protein 1-like isoform X2 170.16600 0.2376208 0.1144210 0.0558266 0.0795817
GB45370 DNA-directed RNA polymerase I subunit RPA2 isoform X2 170.03043 0.0207095 -0.0427381 -0.4123049 -0.0850423
GB44414 alpha-mannosidase 2 isoform X1 169.96329 -0.1246265 -0.0808181 0.0591496 -0.0464710
GB40463 ethanolaminephosphotransferase 1-like 169.76706 -0.0372503 0.0365725 -0.0518489 0.1223341
GB54300 probable U2 small nuclear ribonucleoprotein A’ isoform X1 169.48055 -0.0599139 0.0316384 -0.0458707 0.1001505
GB42451 serine/threonine-protein kinase TBK1 169.37036 -0.3205615 0.1376725 0.0047741 0.1421056
GB50972 gastrulation defective protein 1 homolog 169.31805 -0.1971693 0.0657208 0.1903877 -0.0034529
GB51706 histone-lysine N-methyltransferase SETD2-like isoform X1 169.31045 -0.4481025 -0.0162006 0.0935864 0.1184476
GB54377 male-specific lethal 1 homolog 169.30235 -0.0107089 0.0787733 0.0791723 -0.3478216
GB52165 probable ATP-dependent RNA helicase YTHDC2 isoform X1 169.14874 -0.2166006 -0.1492968 -0.0495434 0.1044721
GB40320 protein tumorous imaginal discs, mitochondrial-like isoform X1 169.05348 -0.1619242 0.0041297 0.0375536 -0.0424999
GB51655 nucleoporin GLE1-like 168.83463 -0.0847804 -0.0635058 -0.0393827 0.0140765
GB42997 uncharacterized protein LOC100578201 168.75985 -0.3800505 0.1690311 0.1112928 0.0019192
GB40563 threonine–tRNA ligase, cytoplasmic-like isoform X1 168.65026 0.1893858 0.0081525 -0.0304706 -0.0437406
GB43815 probable 39S ribosomal protein L23, mitochondrial-like isoform X1 168.32631 -0.1585833 -0.0029415 -0.0209984 0.0871642
GB42645 kinesin B 168.28858 -0.5371475 0.2744939 0.1776832 -0.0702883
GB42933 serine/threonine-protein kinase TAO1 isoform X2 168.16786 -0.1176620 -0.0135005 -0.1030836 -0.0665595
GB53934 rho GTPase-activating protein 24-like 168.01757 -0.3242732 0.0554416 -0.0384074 0.1041209
GB52990 BRISC and BRCA1-A complex member 1-like 167.99128 -0.3254478 0.1174936 0.0108915 0.0004634
GB42381 E3 ubiquitin-protein ligase RNF126-like isoform X5 167.95791 -0.0659800 0.0049379 0.0546401 0.0810624
GB55397 vesicle-associated membrane protein 7 167.88748 0.1419213 -0.0867286 -0.0365991 0.0521229
GB53172 ADAM 17-like protease-like isoform 2 167.54930 0.0748085 -0.0450701 0.0236531 0.1024472
GB44189 glutamic acid-rich protein-like 167.43525 0.0880143 0.0526048 -0.0479209 -0.0654774
GB44397 regulator of microtubule dynamics protein 1-like isoform X1 167.40823 -0.1989022 -0.0226060 -0.0122923 0.0010582
GB49996 regulator of G-protein signaling loco isoform X4 167.17637 -0.0093953 -0.0241350 0.0663415 0.1139634
GB50589 DDRGK domain-containing protein 1-like 166.95040 -0.1019996 -0.0952753 -0.0483397 0.0635181
GB53147 cell division cycle protein 16 homolog isoform X2 166.63509 -0.1296634 0.1834347 0.1533974 0.0234167
GB47744 sorting nexin-25-like 166.61334 -0.0488921 -0.0729742 0.1539323 0.1408092
GB47826 alkylated DNA repair protein alkB homolog 8-like 166.42901 -0.5753528 -0.0646846 -0.0830894 0.0462685
GB44104 V-type proton ATPase subunit G 166.40192 0.0170920 -0.0168743 0.0833584 0.0707069
GB40780 zinc finger protein 330 homolog 166.14575 -0.4061068 0.0770956 0.0679618 0.0914965
GB50183 cylicin-2-like 166.13693 0.1655849 0.0167800 0.2181523 -0.1644786
GB51867 ubiquitin carboxyl-terminal hydrolase isozyme L5 166.11528 -0.0131991 0.0253632 -0.0453921 0.1260061
GB53132 trifunctional enzyme subunit beta, mitochondrial-like 166.07786 0.2534760 -0.0294923 -0.1399508 0.1851779
GB41755 vacuolar protein sorting-associated protein 37A 165.53325 0.1859728 0.0709252 0.0751567 -0.0271144
GB48266 Hermansky-Pudlak syndrome 3 protein homolog 165.22780 -0.1460207 -0.0912595 0.1312040 0.1240288
GB51701 CUE domain-containing protein 1 165.13770 -0.2843529 -0.2020643 -0.0828381 0.1441842
GB49608 protein angel-like isoform X1 164.99695 -0.4745777 -0.1501227 0.0097089 -0.3911702
GB53228 vacuolar protein sorting-associated protein 37B-like 164.95976 -0.1001412 0.0324804 0.0516558 0.0672719
GB45119 elongation factor Ts, mitochondrial-like 164.90078 0.4157426 -0.0401995 0.0311234 -0.0351009
GB45360 exportin-2 164.63346 0.3306912 0.1146233 -0.0533202 0.0391325
GB49226 tetratricopeptide repeat protein 1-like 164.56124 -0.1312727 0.0647437 -0.0042155 0.1193453
GB50920 39S ribosomal protein L37, mitochondrial 164.53509 -0.0627923 0.0821423 -0.0219706 0.0439987
GB54957 anaphase-promoting complex subunit 7 isoform X1 164.37643 0.1083459 -0.0770647 0.0286664 -0.0151621
GB55017 putative GTP-binding protein 6-like isoform X1 164.24508 -0.4279412 0.0980476 0.2020634 0.0654012
GB42207 eukaryotic translation initiation factor 2D-like isoform X2 164.23052 -0.4402548 -0.1878352 0.0848978 0.0844453
GB48145 tyrosine-protein phosphatase non-receptor type 61F-like 164.16294 -0.3001985 0.3129825 -0.0224264 0.3619577
GB44883 protein bunched, class 2/F/G isoform isoform X2 164.08452 0.1423153 0.0431774 0.1096459 0.0820739
GB54809 cell wall protein IFF6-like isoform X1 164.07411 -0.2793603 0.0938404 0.0189103 -0.0487562
GB46339 heat shock protein 75 kDa, mitochondrial isoform 1 163.97346 0.2227431 0.0858850 0.0825314 0.1098457
102654871 DCN1-like protein 3-like 163.73872 -0.5446257 -0.1149403 -0.0529742 -0.0266523
GB44262 spectrin beta chain, non-erythrocytic 5 isoform X4 163.63779 -0.0348910 -0.0986757 -0.1006847 -0.0922269
GB54321 RuvB-like 2 isoform X1 163.57363 0.2691298 0.0885141 0.1077559 -0.0199705
GB13213 eukaryotic translation initiation factor 4 gamma 163.51563 -0.3398430 0.0132426 -0.0498854 0.0745579
GB52916 phosphatidylinositide phosphatase SAC2-like isoform X2 163.51474 -0.2041823 0.0025506 0.1583330 0.1866605
GB51426 asparagine synthetase domain-containing protein 1 isoform X6 163.37313 -0.1068022 -0.1522976 0.0818879 0.0731652
GB44028 vacuolar protein sorting-associated protein 35 isoform X2 163.27214 -0.0579076 -0.3461417 0.0382400 -0.0489067
GB45341 polypeptide N-acetylgalactosaminyltransferase 35A-like 163.09388 -0.4167607 0.0881717 1.6656021 -0.0117249
GB54701 suppressor of G2 allele of SKP1 homolog isoformX1 162.66754 -0.1767265 0.1201854 -0.0086041 1.0849255
GB42667 trafficking protein particle complex subunit 4-like 162.08771 -0.2197603 -0.1750175 0.0386779 -0.0055323
GB41333 DNA-directed RNA polymerase III subunit RPC1-like isoform X1 161.61636 -0.1577234 0.1680904 -0.1650504 -0.3751015
GB54198 liprin-alpha-2-like isoform X13 161.55086 -0.1542755 -0.0349291 0.3996912 0.0008822
GB40399 synaptobrevin homolog YKT6 isoformX1 161.40256 -0.0445405 0.0481756 0.0212926 -0.0047779
GB44449 putative 28S ribosomal protein S5, mitochondrial isoform X1 161.33064 0.1662338 -0.0282685 0.0311763 0.0062591
GB44293 lisH domain and HEAT repeat-containing protein KIAA1468 homolog isoform X1 161.00406 -0.3920475 -0.0260276 0.0587180 -0.0768334
GB55595 probable 39S ribosomal protein L24, mitochondrial 160.66970 -0.2371454 -0.0241757 0.0492170 0.0447080
GB49250 heme oxygenase isoform X1 160.54774 -0.7061596 -0.1862855 0.0368602 0.0448400
GB47236 micronuclear linker histone polyprotein isoform X1 160.44234 -0.0470159 0.0382495 0.0640319 0.0621723
GB49158 dynactin subunit 2, transcript variant X2 159.93667 -0.0774768 0.0718003 -0.2085030 0.1296526
GB47884 TELO2-interacting protein 2-like isoform X1 159.81577 -0.2698585 0.3018826 0.1126823 0.1121113
GB55913 integrator complex subunit 2 159.76275 -0.3696034 0.0859222 0.0421902 -0.0477617
GB46147 uncharacterized protein LOC408724 159.23819 0.1867932 -